diff --git a/_sources/docs/spec_prop/hf_param_energy.ipynb b/_sources/docs/spec_prop/hf_param_energy.ipynb index b3ace1421..076065ae5 100644 --- a/_sources/docs/spec_prop/hf_param_energy.ipynb +++ b/_sources/docs/spec_prop/hf_param_energy.ipynb @@ -171,7 +171,8 @@ "source": [ "In order, we have introduced:\n", "\n", - "1. The Hermitian electronic Hessian\n", + "The Hermitian electronic Hessian\n", + "\n", "$$\n", "\\mathbf{E}^{[2]} = \n", "\\begin{pmatrix}\n", @@ -179,7 +180,9 @@ "\\mathbf{B}^* & \\mathbf{A}^* \\\\\n", "\\end{pmatrix}\n", "$$\n", + "\n", "with blocks\n", + "\n", "$$\n", "A_{mn} =\n", "\\left.\n", @@ -211,7 +214,8 @@ "tags": [] }, "source": [ - "2. The (unknown) response vector\n", + "The (unknown) response vector\n", + "\n", "$$\n", "\\mathbf{N} =\n", "\\begin{pmatrix}\n", @@ -219,7 +223,9 @@ "\\mathbf{Z}^*\n", "\\end{pmatrix}\n", "$$\n", + "\n", "with \n", + "\n", "$$\n", "Z_n = \n", "\\left.\n", @@ -239,7 +245,8 @@ "tags": [] }, "source": [ - "3. And the property gradient\n", + "And the property gradient\n", + "\n", "$$\n", "\\mathbf{B}^{[1]} =\n", "\\begin{pmatrix}\n", @@ -247,7 +254,9 @@ "\\mathbf{g}^* \\\\\n", "\\end{pmatrix}\n", "$$\n", + "\n", "with\n", + "\n", "$$\n", "g_m = \n", "\\left.\n", diff --git a/_sources/docs/tutorials/vib_ir_exercises.ipynb b/_sources/docs/tutorials/vib_ir_exercises.ipynb index 7b635fc38..82ed2832f 100644 --- a/_sources/docs/tutorials/vib_ir_exercises.ipynb +++ b/_sources/docs/tutorials/vib_ir_exercises.ipynb @@ -417,11 +417,11 @@ "# Either optimize the geometries\n", "# Uncomment below\n", "# ethene_opt_drv.ostream.unmute()\n", - "# opt_ethene = ethene_opt_drv.compute(ethene, ethene_basis, ethene_scf_drv)\n", + "# opt_ethene = ethene_opt_drv.compute(ethene, ethene_basis)\n", "# fluoroethene_opt_drv.ostream.unmute()\n", - "# opt_fluoroethene = fluoroethene_opt_drv.compute(fluoroethene, fluoroethene_basis, fluoroethene_scf_drv)\n", + "# opt_fluoroethene = fluoroethene_opt_drv.compute(fluoroethene, fluoroethene_basis)\n", "# chloroethene_opt_drv.ostream.unmute()\n", - "# opt_chloroethene = chloroethene_opt_drv.compute(chloroethene, chloroethene_basis, chloroethene_scf_drv)\n", + "# opt_chloroethene = chloroethene_opt_drv.compute(chloroethene, chloroethene_basis)\n", "\n", "# Or read them from file if already calculated\n", "opt_ethene = vlx.Molecule.read_xyz_file(\"../../data/ir_raman/opt_ethene.xyz\")\n", @@ -624,9 +624,9 @@ "chloroethene_hessian_drv.update_settings(method_settings, hessian_settings)\n", "\n", "# Calculate\n", - "# ethene_hessian_drv.compute(ethene, ethene_basis, ethene_scf_drv)\n", - "# fluoroethene_hessian_drv.compute(fluoroethene, fluoroethene_basis, fluoroethene_scf_drv)\n", - "# chloroethene_hessian_drv.compute(chloroethene, chloroethene_basis, chloroethene_scf_drv)\n", + "# ethene_hessian_drv.compute(ethene, ethene_basis)\n", + "# fluoroethene_hessian_drv.compute(fluoroethene, fluoroethene_basis)\n", + "# chloroethene_hessian_drv.compute(chloroethene, chloroethene_basis)\n", "\n", "# Or read from file:\n", "import h5py\n", diff --git a/docs/spec_prop/hf_param_energy.html b/docs/spec_prop/hf_param_energy.html index 406ea08bb..9802f247b 100644 --- a/docs/spec_prop/hf_param_energy.html +++ b/docs/spec_prop/hf_param_energy.html @@ -738,75 +738,69 @@

Linear response equation -
  • The Hermitian electronic Hessian -$$ -\mathbf{E}^{[2]} =

  • - -
    -()#\[\begin{pmatrix} +

    The Hermitian electronic Hessian

    +
    +\[\begin{split} +\mathbf{E}^{[2]} = +\begin{pmatrix} \mathbf{A} & \mathbf{B} \\ \mathbf{B}^* & \mathbf{A}^* \\ -\end{pmatrix}\]
    +\end{pmatrix} +\end{split}\]
    +

    with blocks

    \[ -with blocks -\]
    -

    A_{mn} = +A_{mn} = \left. \frac{ \partial^2 E(\kappa, F) }{ \partial \kappa_{m}^* \partial \kappa_{n} } -\right|{F = 0} ; \qquad -B{mn} = +\right|_{F = 0} ; \qquad +B_{mn} = \left. \frac{ \partial^2 E(\kappa, F) }{ \partial \kappa_{m}^* \partial \kappa_{n}^* } -\right|_{F = 0} -$$

    -
      -
    1. The (unknown) response vector -$$ -\mathbf{N} =

    2. -
    -
    -()#\[\begin{pmatrix} +\right|_{F = 0} +\]
    +

    The (unknown) response vector

    +
    +\[\begin{split} +\mathbf{N} = +\begin{pmatrix} \mathbf{Z} \\ \mathbf{Z}^* -\end{pmatrix}\]
    +\end{pmatrix} +\end{split}\] +

    with

    \[ -with -\]
    -

    Z_n = +Z_n = \left. \frac{d \kappa_n}{d F_\alpha} \right|_{F=0} -$$

    -
      -
    1. And the property gradient -$$ -\mathbf{B}^{[1]} =

    2. -
    -
    -()#\[\begin{pmatrix} +\]
    +

    And the property gradient

    +
    +\[\begin{split} +\mathbf{B}^{[1]} = +\begin{pmatrix} \mathbf{g} \\ \mathbf{g}^* \\ -\end{pmatrix}\]
    +\end{pmatrix} +\end{split}\] +

    with

    \[ -with -\]
    -

    g_m = +g_m = \left. \frac{\partial^2 E(\kappa, F)}{\partial \kappa_{m}^* \partial F_\alpha} \right|_{F=0} -$$

    +\]

    Baker–Campbell–Hausdorff expansion#

    diff --git a/docs/tutorials/vib_ir.html b/docs/tutorials/vib_ir.html index b0e672566..4e354e3e8 100644 --- a/docs/tutorials/vib_ir.html +++ b/docs/tutorials/vib_ir.html @@ -32,7 +32,7 @@ - + diff --git a/docs/tutorials/vib_ir_exercises.html b/docs/tutorials/vib_ir_exercises.html index 7136de530..20ae69277 100644 --- a/docs/tutorials/vib_ir_exercises.html +++ b/docs/tutorials/vib_ir_exercises.html @@ -32,7 +32,7 @@ - + @@ -736,8 +736,8 @@

    Exercises -
    -

    You appear to be running in JupyterLab (or JavaScript failed to load for some other reason). You need to install the 3dmol extension:
    +

    +

    You appear to be running in JupyterLab (or JavaScript failed to load for some other reason). You need to install the 3dmol extension:
    jupyter labextension install jupyterlab_3dmol

    @@ -901,11 +901,11 @@

    SCF geometry optimization
    -
    -

    You appear to be running in JupyterLab (or JavaScript failed to load for some other reason). You need to install the 3dmol extension:
    +

    +

    You appear to be running in JupyterLab (or JavaScript failed to load for some other reason). You need to install the 3dmol extension:
    jupyter labextension install jupyterlab_3dmol

    @@ -1509,9 +1509,9 @@

    IR intensities and Raman activities
    Ground state dipole moments:   x             y            z       
     
    -Ethene                     : -0.00 a.u.     0.00 a.u.    0.00 a.u.
    +Ethene                     : -0.00 a.u.    -0.00 a.u.    0.00 a.u.
     Fluoroethene               : -0.79 a.u.     0.39 a.u.    0.00 a.u.
    -Chloroethene               : -0.77 a.u.     0.59 a.u.    0.00 a.u.
    +Chloroethene               : -0.77 a.u.     0.59 a.u.   -0.00 a.u.
     
    ../../_images/75eb082131ad89bdf34395705681e4ae4272c06d2c3820404c5f5b767895fa05.png diff --git a/searchindex.js b/searchindex.js index ec3e396a0..fa77c0596 100644 --- a/searchindex.js +++ b/searchindex.js @@ -1 +1 @@ -Search.setIndex({"docnames": ["docs/basics_notebook", "docs/cite", "docs/elec_struct/available_xcfun", "docs/elec_struct/ci", "docs/elec_struct/correlation", "docs/elec_struct/dft", "docs/elec_struct/dft_prop", "docs/elec_struct/dft_scf", "docs/elec_struct/dispersion", "docs/elec_struct/elstruct_gen", "docs/elec_struct/fock_diagonalize", "docs/elec_struct/group_theory", "docs/elec_struct/hartree-fock", "docs/elec_struct/hf_example", "docs/elec_struct/hf_scf", "docs/elec_struct/hf_theory", "docs/elec_struct/hohenberg", "docs/elec_struct/integrals", "docs/elec_struct/kernel_int", "docs/elec_struct/kohn-sham", "docs/elec_struct/mcpdft", "docs/elec_struct/mcscf", "docs/elec_struct/mp2", "docs/elec_struct/multiref", "docs/elec_struct/natural_orbitals", "docs/elec_struct/operators", "docs/elec_struct/orbitals", "docs/elec_struct/pt", "docs/elec_struct/reduced_density", "docs/elec_struct/second_quant", "docs/elec_struct/slater", "docs/elec_struct/spin", "docs/elec_struct/wft", "docs/elec_struct/wft_exercises", "docs/env/chelpg", "docs/env/embedding", "docs/env/esp", "docs/env/localprop", "docs/env/loprop", "docs/env/nonpol_emb", "docs/env/pol_emb", "docs/env/resp", "docs/install", "docs/intro", "docs/mol_struct/conformer", "docs/mol_struct/coordinates", "docs/mol_struct/energy_grad", "docs/mol_struct/forcefields", "docs/mol_struct/gradients", "docs/mol_struct/hessians", "docs/mol_struct/hessians_vib", "docs/mol_struct/impes", "docs/mol_struct/impes_calc", "docs/mol_struct/md", "docs/mol_struct/md_run", "docs/mol_struct/md_setup", "docs/mol_struct/molstruct_gen", "docs/mol_struct/opt", "docs/mol_struct/opt_constrained", "docs/mol_struct/opt_gs", "docs/mol_struct/opt_struct", "docs/mol_struct/property_grad", "docs/mol_struct/reparameterize", "docs/mol_struct/symmetry", "docs/mol_struct/tst", "docs/mol_struct/tst_gen", "docs/mol_struct/vibrations", "docs/refs", "docs/spec_prop/adc", "docs/spec_prop/adc_cvs", "docs/spec_prop/adc_exercises_new", "docs/spec_prop/adc_hpc", "docs/spec_prop/adc_isr", "docs/spec_prop/adc_pp", "docs/spec_prop/birefring", "docs/spec_prop/ci", "docs/spec_prop/cubic_resp", "docs/spec_prop/dichroism", "docs/spec_prop/dipole_equiv", "docs/spec_prop/elec_nuc", "docs/spec_prop/excoupl", "docs/spec_prop/excoupl_impl", "docs/spec_prop/expt_theory", "docs/spec_prop/finite_field", "docs/spec_prop/first_order", "docs/spec_prop/hf", "docs/spec_prop/hf_param_energy", "docs/spec_prop/hf_quasienergy", "docs/spec_prop/kappa_expansion", "docs/spec_prop/linear_resp", "docs/spec_prop/mclr", "docs/spec_prop/mol_prop", "docs/spec_prop/mr_exercises", "docs/spec_prop/mr_response", "docs/spec_prop/nto", "docs/spec_prop/opa", "docs/spec_prop/orb_param_field", "docs/spec_prop/orb_rot", "docs/spec_prop/quad_resp", "docs/spec_prop/resp_external", "docs/spec_prop/rovib", "docs/spec_prop/sa_mcscf", "docs/spec_prop/selection_rules", "docs/spec_prop/spectra_aspects", "docs/spec_prop/tddft", "docs/spec_prop/tddft_charge_transfer", "docs/spec_prop/tddft_cvs", "docs/spec_prop/tddft_excited_states", "docs/spec_prop/tddft_foundation", "docs/spec_prop/tddft_linear_response", "docs/spec_prop/tddft_lr_implementation", "docs/spec_prop/tddft_lr_theory", "docs/spec_prop/tddft_quasienergy", "docs/spec_prop/tddft_rpa", "docs/spec_prop/tddft_spin_flip", "docs/spec_prop/tddft_tda", "docs/spec_prop/tddft_triplet_inst", "docs/spec_prop/tpa", "docs/spec_prop/wavefunction", "docs/title", "docs/tutorials/correlation", "docs/tutorials/openshells", "docs/tutorials/rest_unrest", "docs/tutorials/uv_vis", "docs/tutorials/uv_vis_absorption", "docs/tutorials/uv_vis_analysis", "docs/tutorials/uv_vis_exercises", "docs/tutorials/uv_vis_fluorescence", "docs/tutorials/uv_vis_rec", "docs/tutorials/vib_ir", "docs/tutorials/vib_ir_calc", "docs/tutorials/vib_ir_exercises", "docs/tutorials/vib_ir_raman", "docs/tutorials/wf_build", "docs/tutorials/wf_construct", "docs/tutorials/wf_gwp", "docs/tutorials/wf_methane", "docs/tutorials/wf_scf", "docs/tutorials/wf_spectra", "docs/tutorials/wf_struct", "docs/tutorials/workflow", "docs/tutorials/xray", "docs/tutorials/xray_analysis", "docs/tutorials/xray_aspects", "docs/tutorials/xray_calc", "docs/tutorials/xray_cheatsheet", "docs/tutorials/xray_exercises", "docs/tutorials/xray_large", "docs/tutorials/xray_nonstandard", "docs/tutorials/xray_rec", "docs/units_notation", "docs/visualize/broadening", "docs/visualize/elec_struct", "docs/visualize/exc_vis", "docs/visualize/md_vis", "docs/visualize/mol_struct", "docs/visualize/opt_vib_vis", "docs/visualize/orb_vis", "docs/visualize/spec_prop", "docs/visualize/struct_vis"], "filenames": ["docs/basics_notebook.ipynb", "docs/cite.ipynb", "docs/elec_struct/available_xcfun.ipynb", "docs/elec_struct/ci.ipynb", "docs/elec_struct/correlation.ipynb", "docs/elec_struct/dft.ipynb", "docs/elec_struct/dft_prop.ipynb", "docs/elec_struct/dft_scf.ipynb", "docs/elec_struct/dispersion.ipynb", "docs/elec_struct/elstruct_gen.ipynb", "docs/elec_struct/fock_diagonalize.ipynb", "docs/elec_struct/group_theory.ipynb", "docs/elec_struct/hartree-fock.ipynb", "docs/elec_struct/hf_example.ipynb", "docs/elec_struct/hf_scf.ipynb", "docs/elec_struct/hf_theory.ipynb", "docs/elec_struct/hohenberg.ipynb", "docs/elec_struct/integrals.ipynb", "docs/elec_struct/kernel_int.ipynb", "docs/elec_struct/kohn-sham.ipynb", "docs/elec_struct/mcpdft.ipynb", "docs/elec_struct/mcscf.ipynb", "docs/elec_struct/mp2.ipynb", "docs/elec_struct/multiref.ipynb", "docs/elec_struct/natural_orbitals.ipynb", "docs/elec_struct/operators.ipynb", "docs/elec_struct/orbitals.ipynb", "docs/elec_struct/pt.ipynb", "docs/elec_struct/reduced_density.ipynb", "docs/elec_struct/second_quant.ipynb", "docs/elec_struct/slater.ipynb", "docs/elec_struct/spin.ipynb", "docs/elec_struct/wft.ipynb", "docs/elec_struct/wft_exercises.ipynb", "docs/env/chelpg.ipynb", "docs/env/embedding.ipynb", "docs/env/esp.ipynb", "docs/env/localprop.ipynb", "docs/env/loprop.ipynb", "docs/env/nonpol_emb.ipynb", "docs/env/pol_emb.ipynb", "docs/env/resp.ipynb", "docs/install.ipynb", "docs/intro.ipynb", "docs/mol_struct/conformer.ipynb", "docs/mol_struct/coordinates.ipynb", "docs/mol_struct/energy_grad.ipynb", "docs/mol_struct/forcefields.ipynb", "docs/mol_struct/gradients.ipynb", "docs/mol_struct/hessians.ipynb", "docs/mol_struct/hessians_vib.ipynb", "docs/mol_struct/impes.ipynb", "docs/mol_struct/impes_calc.ipynb", "docs/mol_struct/md.ipynb", "docs/mol_struct/md_run.ipynb", "docs/mol_struct/md_setup.ipynb", "docs/mol_struct/molstruct_gen.ipynb", "docs/mol_struct/opt.ipynb", "docs/mol_struct/opt_constrained.ipynb", "docs/mol_struct/opt_gs.ipynb", "docs/mol_struct/opt_struct.ipynb", "docs/mol_struct/property_grad.ipynb", "docs/mol_struct/reparameterize.ipynb", "docs/mol_struct/symmetry.ipynb", "docs/mol_struct/tst.ipynb", "docs/mol_struct/tst_gen.ipynb", "docs/mol_struct/vibrations.ipynb", "docs/refs.md", "docs/spec_prop/adc.ipynb", "docs/spec_prop/adc_cvs.ipynb", "docs/spec_prop/adc_exercises_new.ipynb", "docs/spec_prop/adc_hpc.ipynb", "docs/spec_prop/adc_isr.ipynb", "docs/spec_prop/adc_pp.ipynb", "docs/spec_prop/birefring.ipynb", "docs/spec_prop/ci.ipynb", "docs/spec_prop/cubic_resp.ipynb", "docs/spec_prop/dichroism.ipynb", "docs/spec_prop/dipole_equiv.ipynb", "docs/spec_prop/elec_nuc.ipynb", "docs/spec_prop/excoupl.ipynb", "docs/spec_prop/excoupl_impl.ipynb", "docs/spec_prop/expt_theory.ipynb", "docs/spec_prop/finite_field.ipynb", "docs/spec_prop/first_order.ipynb", "docs/spec_prop/hf.ipynb", "docs/spec_prop/hf_param_energy.ipynb", "docs/spec_prop/hf_quasienergy.ipynb", "docs/spec_prop/kappa_expansion.ipynb", "docs/spec_prop/linear_resp.ipynb", "docs/spec_prop/mclr.ipynb", "docs/spec_prop/mol_prop.ipynb", "docs/spec_prop/mr_exercises.ipynb", "docs/spec_prop/mr_response.ipynb", "docs/spec_prop/nto.ipynb", "docs/spec_prop/opa.ipynb", "docs/spec_prop/orb_param_field.ipynb", "docs/spec_prop/orb_rot.ipynb", "docs/spec_prop/quad_resp.ipynb", "docs/spec_prop/resp_external.ipynb", "docs/spec_prop/rovib.ipynb", "docs/spec_prop/sa_mcscf.ipynb", "docs/spec_prop/selection_rules.ipynb", "docs/spec_prop/spectra_aspects.ipynb", "docs/spec_prop/tddft.ipynb", "docs/spec_prop/tddft_charge_transfer.ipynb", "docs/spec_prop/tddft_cvs.ipynb", "docs/spec_prop/tddft_excited_states.ipynb", "docs/spec_prop/tddft_foundation.ipynb", "docs/spec_prop/tddft_linear_response.ipynb", "docs/spec_prop/tddft_lr_implementation.ipynb", "docs/spec_prop/tddft_lr_theory.ipynb", "docs/spec_prop/tddft_quasienergy.ipynb", "docs/spec_prop/tddft_rpa.ipynb", "docs/spec_prop/tddft_spin_flip.ipynb", "docs/spec_prop/tddft_tda.ipynb", "docs/spec_prop/tddft_triplet_inst.ipynb", "docs/spec_prop/tpa.ipynb", "docs/spec_prop/wavefunction.ipynb", "docs/title.md", "docs/tutorials/correlation.ipynb", "docs/tutorials/openshells.ipynb", "docs/tutorials/rest_unrest.ipynb", "docs/tutorials/uv_vis.ipynb", "docs/tutorials/uv_vis_absorption.ipynb", "docs/tutorials/uv_vis_analysis.ipynb", "docs/tutorials/uv_vis_exercises.ipynb", "docs/tutorials/uv_vis_fluorescence.ipynb", "docs/tutorials/uv_vis_rec.ipynb", "docs/tutorials/vib_ir.ipynb", "docs/tutorials/vib_ir_calc.ipynb", "docs/tutorials/vib_ir_exercises.ipynb", "docs/tutorials/vib_ir_raman.ipynb", "docs/tutorials/wf_build.ipynb", "docs/tutorials/wf_construct.ipynb", "docs/tutorials/wf_gwp.ipynb", "docs/tutorials/wf_methane.ipynb", "docs/tutorials/wf_scf.ipynb", "docs/tutorials/wf_spectra.ipynb", "docs/tutorials/wf_struct.ipynb", "docs/tutorials/workflow.ipynb", "docs/tutorials/xray.ipynb", "docs/tutorials/xray_analysis.ipynb", "docs/tutorials/xray_aspects.ipynb", "docs/tutorials/xray_calc.ipynb", "docs/tutorials/xray_cheatsheet.ipynb", "docs/tutorials/xray_exercises.ipynb", "docs/tutorials/xray_large.ipynb", "docs/tutorials/xray_nonstandard.ipynb", "docs/tutorials/xray_rec.ipynb", "docs/units_notation.ipynb", "docs/visualize/broadening.ipynb", "docs/visualize/elec_struct.ipynb", "docs/visualize/exc_vis.ipynb", "docs/visualize/md_vis.ipynb", "docs/visualize/mol_struct.ipynb", "docs/visualize/opt_vib_vis.ipynb", "docs/visualize/orb_vis.ipynb", "docs/visualize/spec_prop.ipynb", "docs/visualize/struct_vis.ipynb"], "titles": ["Using Jupyter notebooks", "How to cite and contact", "Available XC functionals", "Configuration interaction", "Electron correlation", "Density functional theory", "First-order properties", "SCF optimization", "Dispersion interactions", "General aspects", "Fock matrix diagonalization", "Symmetry", "Hartree\u2013Fock", "HF in VeloxChem", "SCF optimization", "Hartree\u2013Fock theory", "Hohenberg\u2013Kohn theorems", "Integrals", "Kernel integration", "Kohn\u2013Sham method", "MC-PDFT", "MCSCF", "M\u00f8ller\u2013Plesset", "Multireference methods", "Natural orbitals", "Operators and matrix elements", "Orbitals and basis sets", "Rayleigh\u2013Schr\u00f6dinger perturbation theory", "Reduced particle densities", "Second quantization", "Many-electron wave functions", "Electron spin", "Wave function theory", "Exercises", "CHELPG charges", "Embedding potentials", "ESP charges", "Localized properties", "LoProp charges and polarisabilities", "Non-polarizable embedding", "Polarizable embedding", "RESP charges", "Installation", "Getting started", "Conformer search", "Choice of coordinates", "Energy gradients", "Force fields", "Gradients", "Molecular Hessians", "Hessians and vibrations", "PES interpolation techniques", "Constructing the PES by interpolation", "Molecular dynamics", "Running a simulation", "Ensembles and time integration", "General aspects", "Structure optimization", "Constrained coordinates", "Ground state", "Optimization methods", "Property gradients", "Reparameterize force fields", "Molecular symmetry", "Transition-state theory", "Transition state", "Vibrational analysis", "References", "Algebraic-diagrammatic construction", "Core-valence separation", "Exercises", "HPC-QC implementation", "Intermediate state representation", "Polarization propagator", "Birefringences and dichroisms", "Configuration interaction", "Cubic response", "Dichroism", "Dipole equivalence relations", "Electronic and nuclear contributions", "Exciton coupling model", "Implementation", "Experiment to theory", "Finite field method", "First-order properties", "Hartree\u2013Fock", "Energy determination of parameters", "Quasi-energy determination of parameters", "Time-dependence of observables", "Linear Response", "Linear response", "Molecular properties", "Exercises", "Multireference methods", "Natural transition orbitals", "UV/vis absorption", "Field-dependence of parameters", "Orbital rotations", "Quadratic response", "Responses to external fields", "Rovibronic states", "State-averaged MCSCF", "Selection rules", "General aspects", "Time-dependent DFT", "Charge transfer", "Core-valence separation", "Excited states", "Foundations", "Linear response", "Implementation", "Theory", "Quasi-energy", "RPA equation", "Spin-flip", "Tamm\u2013Dancoff approximation", "Triplet instability", "Two-photon absorption", "Wave function methods", "
    Computational Chemistry from Laptop to HPC
    ", "Static versus dynamic correlation correlation", "Open shells", "Restricted versus unrestricted", "UV/vis spectroscopies", "Absorption", "Analysis", "Exercises", "Fluorescence", "Recommendations", "Vibrational spectroscopies", "IR spectroscopy", "Exercises", "Raman spectroscopy", "Building systems", "Assembling a full workflow", "Global warming potential", "Methane combustion energy", "Optimizing electronic structure", "From structure to spectrum", "Optimizing molecular structure", "Constructing workflows", "X-ray spectroscopies", "Spectrum analysis", "Special aspects", "Spectrum calculation", "Cheat sheet", "Exercises", "Larger systems", "Non-standard calculations", "Recommendations", "Units and notation", "Spectrum broadening", "Electronic structure", "Excited states", "MD trajectories", "Molecular structure and dynamics", "Optimization and normal modes", "Orbitals and densities", "Spectra and properties", "Molecular structure"], "terms": {"we": [0, 1, 2, 3, 4, 5, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, 23, 24, 25, 26, 27, 28, 29, 30, 31, 32, 33, 34, 36, 37, 38, 39, 40, 41, 42, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 57, 58, 59, 60, 62, 64, 65, 69, 70, 71, 72, 75, 76, 78, 80, 82, 83, 84, 86, 88, 89, 90, 91, 92, 93, 94, 96, 97, 98, 99, 100, 101, 102, 103, 105, 106, 108, 111, 113, 115, 119, 120, 121, 122, 123, 124, 125, 128, 130, 131, 132, 133, 136, 137, 139, 141, 142, 143, 144, 145, 147, 148, 149, 150, 151, 153, 154, 155, 156, 157, 159], "here": [0, 3, 4, 6, 8, 11, 15, 19, 20, 21, 22, 25, 29, 33, 34, 38, 41, 45, 46, 47, 49, 52, 54, 55, 59, 60, 61, 62, 64, 66, 68, 69, 70, 71, 72, 76, 82, 86, 88, 91, 92, 96, 97, 100, 101, 104, 105, 111, 113, 122, 124, 125, 126, 128, 129, 130, 132, 136, 137, 139, 141, 142, 143, 144, 145, 147, 148, 149, 152, 153, 157, 159], "go": [0, 8, 19, 20, 21, 33, 42, 43, 70, 82, 90, 101, 130, 131, 132, 133, 143, 144, 153, 156], "over": [0, 3, 8, 15, 16, 20, 21, 24, 25, 28, 33, 38, 39, 47, 49, 52, 55, 60, 66, 70, 72, 73, 74, 76, 82, 88, 89, 91, 92, 97, 99, 100, 101, 105, 108, 111, 117, 120, 124, 132, 143, 144, 149, 150, 153], "basic": [0, 16, 33, 43, 45, 53, 55, 56, 108, 133, 141, 153], "focu": [0, 16, 29, 38, 43, 47, 82, 90, 96, 106, 124, 125, 129, 141, 142, 144, 147, 148, 149, 157, 158], "carri": [0, 7, 19, 20, 43, 45, 46, 50, 52, 66, 70, 82, 83, 156], "out": [0, 1, 3, 7, 19, 25, 27, 29, 31, 34, 36, 38, 41, 43, 45, 46, 47, 50, 52, 61, 66, 70, 73, 82, 83, 86, 88, 94, 97, 101, 115, 120, 124, 130, 142, 144, 156, 159], "analyz": [0, 18, 70, 76, 89, 101, 117, 124, 134, 153], "quantum": [0, 1, 3, 4, 5, 11, 12, 20, 26, 31, 35, 36, 39, 41, 43, 45, 47, 51, 52, 53, 61, 67, 70, 89, 99, 102, 111, 119, 120, 122, 125, 139, 143, 148, 150], "chemic": [0, 5, 16, 26, 43, 45, 47, 52, 53, 56, 64, 67, 69, 130, 139, 140, 141, 142, 143, 144, 148, 153], "well": [0, 2, 3, 5, 8, 12, 18, 20, 21, 22, 25, 27, 31, 38, 43, 44, 45, 46, 47, 52, 53, 54, 56, 57, 58, 60, 67, 70, 71, 74, 76, 88, 89, 91, 99, 100, 105, 111, 120, 121, 122, 123, 124, 125, 128, 133, 139, 142, 143, 144, 145, 148, 149, 152, 153, 154, 156], "differ": [0, 3, 4, 7, 11, 18, 20, 21, 22, 25, 29, 33, 34, 36, 37, 39, 42, 43, 46, 47, 48, 52, 53, 54, 55, 56, 59, 60, 61, 62, 65, 67, 69, 70, 72, 73, 74, 76, 80, 82, 84, 86, 88, 89, 90, 91, 98, 99, 100, 101, 103, 106, 111, 113, 120, 122, 123, 124, 128, 130, 131, 132, 133, 134, 136, 139, 140, 141, 142, 143, 144, 145, 146, 148, 149, 150, 151, 153, 157, 158, 159], "routin": [0, 10, 33, 52, 60, 62, 70, 124, 148, 154, 156, 157], "ar": [0, 1, 2, 3, 4, 5, 6, 7, 8, 9, 10, 11, 12, 14, 15, 16, 17, 18, 19, 20, 21, 22, 24, 25, 26, 27, 28, 29, 30, 31, 33, 34, 35, 36, 37, 38, 39, 40, 41, 42, 45, 46, 47, 48, 49, 52, 53, 55, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 68, 69, 70, 71, 72, 73, 74, 75, 76, 78, 80, 82, 83, 84, 86, 88, 89, 90, 91, 94, 97, 98, 99, 100, 101, 102, 103, 105, 106, 111, 113, 115, 117, 120, 122, 123, 124, 125, 126, 128, 129, 130, 132, 133, 137, 139, 140, 141, 142, 143, 144, 145, 147, 148, 149, 150, 153, 157], "echem": [0, 1, 13, 20, 21, 43, 100, 120, 125, 143, 148], "At": [0, 3, 8, 11, 33, 46, 69, 72, 82, 96, 105, 137, 143], "first": [0, 3, 4, 5, 7, 8, 10, 11, 13, 14, 15, 16, 18, 19, 20, 21, 22, 33, 34, 36, 39, 40, 41, 45, 47, 48, 49, 52, 55, 60, 61, 62, 64, 65, 66, 67, 70, 72, 73, 74, 76, 82, 83, 86, 88, 89, 90, 91, 92, 94, 96, 99, 100, 101, 103, 105, 106, 111, 113, 115, 120, 122, 124, 125, 130, 131, 132, 133, 136, 142, 144, 148, 150, 153, 154, 156], "glanc": 0, "call": [0, 3, 16, 20, 21, 42, 43, 45, 46, 49, 57, 60, 61, 66, 69, 70, 71, 72, 73, 74, 75, 81, 99, 101, 111, 120, 123, 125, 129, 143, 144], "figur": [0, 3, 4, 7, 8, 11, 14, 18, 20, 21, 28, 31, 33, 41, 43, 47, 52, 60, 62, 65, 69, 70, 73, 75, 81, 82, 92, 96, 99, 101, 102, 105, 106, 113, 120, 123, 124, 125, 130, 131, 132, 133, 142, 143, 144, 145, 148, 151, 156, 157, 159], "book": [0, 1, 13, 35, 43, 62, 67, 91, 103, 150, 153, 157], "can": [0, 3, 4, 6, 8, 10, 11, 13, 14, 16, 17, 18, 19, 20, 21, 22, 24, 25, 26, 28, 29, 31, 33, 34, 38, 39, 42, 43, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 58, 59, 60, 61, 62, 64, 65, 66, 67, 68, 70, 71, 72, 73, 74, 75, 76, 78, 80, 82, 83, 84, 86, 88, 89, 90, 91, 92, 94, 96, 97, 98, 99, 100, 101, 102, 103, 104, 105, 106, 108, 111, 113, 115, 117, 119, 120, 122, 124, 125, 128, 129, 130, 131, 133, 136, 137, 139, 140, 141, 142, 143, 144, 145, 147, 148, 149, 150, 152, 153, 154, 155, 156, 157, 159], "appear": [0, 3, 4, 5, 6, 7, 11, 13, 14, 15, 18, 20, 22, 24, 25, 26, 34, 36, 39, 41, 44, 47, 52, 58, 59, 62, 65, 70, 72, 75, 81, 82, 88, 89, 90, 91, 92, 99, 101, 102, 105, 111, 113, 115, 117, 124, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 151, 153, 154, 156, 157, 159], "bit": [0, 3, 4, 21, 90, 113, 124, 128, 143, 149], "complic": [0, 4, 20, 21, 46, 47, 55, 72, 74, 75, 141, 143, 144], "stress": [0, 133], "you": [0, 1, 3, 4, 6, 7, 11, 13, 14, 18, 20, 21, 22, 24, 25, 26, 33, 34, 36, 39, 41, 42, 43, 44, 47, 52, 58, 59, 62, 65, 70, 72, 75, 81, 88, 90, 91, 92, 101, 102, 105, 113, 115, 124, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 146, 150, 151, 153, 154, 156, 157, 159], "do": [0, 1, 3, 7, 8, 16, 17, 18, 20, 21, 33, 36, 43, 46, 49, 55, 60, 72, 75, 82, 91, 101, 103, 108, 117, 119, 120, 124, 131, 133, 139, 143, 146, 154], "need": [0, 3, 4, 6, 7, 9, 11, 13, 14, 17, 18, 20, 21, 22, 24, 25, 26, 27, 29, 33, 34, 36, 39, 40, 41, 42, 43, 44, 45, 46, 47, 49, 50, 52, 55, 58, 59, 60, 61, 62, 65, 66, 67, 69, 70, 71, 72, 75, 76, 81, 88, 89, 90, 92, 98, 101, 102, 105, 106, 113, 115, 117, 122, 124, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 148, 149, 151, 153, 154, 156, 157, 159], "rememb": [0, 20, 33, 133], "each": [0, 3, 4, 17, 19, 20, 21, 22, 25, 33, 38, 39, 40, 43, 45, 46, 47, 49, 55, 56, 60, 61, 62, 64, 70, 71, 72, 73, 90, 101, 113, 120, 123, 124, 125, 130, 131, 132, 133, 136, 141, 142, 143, 144, 148, 153, 154, 156], "necessarili": [0, 47, 75, 82, 101, 147, 149], "understand": [0, 3, 16, 21, 43, 90, 94, 102, 144, 149], "exact": [0, 3, 4, 7, 12, 19, 21, 22, 27, 31, 46, 67, 75, 84, 100, 101, 105, 108, 118, 143, 149], "detail": [0, 3, 20, 33, 39, 49, 57, 60, 61, 63, 66, 72, 73, 74, 89, 108, 122, 129, 130, 132, 133, 136, 141, 142, 143, 153], "instead": [0, 3, 7, 18, 20, 24, 33, 39, 43, 45, 46, 47, 53, 55, 62, 82, 97, 100, 109, 111, 113, 117, 122, 124, 125, 126, 128, 142, 143, 144, 146, 148, 149, 153, 154, 156], "start": [0, 3, 7, 12, 20, 21, 26, 27, 33, 38, 42, 46, 49, 52, 55, 60, 65, 66, 70, 81, 102, 106, 120, 122, 125, 132, 133, 143, 144, 146, 148, 153, 156], "copi": [0, 70, 101, 106, 125, 143, 144, 145, 148, 153], "interest": [0, 3, 20, 43, 47, 52, 53, 72, 75, 76, 89, 91, 98, 99, 101, 111, 124, 129, 133, 144, 149, 156], "experi": [0, 42, 43, 76, 84, 89, 91, 99, 103, 113, 122, 128, 143, 144, 146, 149], "plai": [0, 74], "around": [0, 4, 20, 21, 33, 47, 52, 53, 55, 62, 82, 91, 96, 108, 113, 120, 124, 139, 143, 145], "i": [0, 1, 2, 3, 4, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15, 17, 18, 19, 20, 21, 22, 24, 25, 26, 27, 28, 29, 30, 31, 33, 34, 36, 38, 39, 40, 41, 42, 43, 44, 45, 46, 47, 48, 49, 50, 52, 53, 54, 55, 57, 59, 60, 61, 62, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 78, 80, 81, 82, 83, 84, 86, 88, 89, 90, 91, 92, 94, 96, 97, 98, 99, 100, 101, 102, 103, 104, 105, 106, 108, 109, 111, 113, 115, 117, 120, 122, 123, 124, 125, 128, 129, 130, 131, 132, 133, 136, 137, 139, 141, 142, 143, 146, 147, 148, 149, 150, 151, 152, 153, 154, 156, 157, 159], "often": [0, 3, 8, 11, 20, 21, 25, 33, 42, 43, 46, 47, 55, 74, 82, 84, 89, 91, 98, 124, 128, 141, 143, 144, 147, 149, 150, 153], "one": [0, 1, 3, 4, 6, 7, 9, 10, 11, 14, 15, 16, 17, 18, 19, 20, 21, 22, 24, 28, 29, 30, 31, 33, 36, 38, 39, 42, 43, 45, 46, 47, 49, 52, 55, 59, 60, 61, 64, 65, 66, 69, 70, 72, 73, 74, 75, 76, 80, 82, 83, 84, 88, 91, 94, 96, 99, 101, 102, 103, 106, 108, 111, 113, 115, 117, 120, 122, 123, 124, 128, 130, 131, 139, 142, 143, 144, 146, 148, 153, 154, 156, 158], "best": [0, 19, 20, 21, 34, 43, 128, 143, 149], "wai": [0, 3, 5, 17, 20, 21, 23, 29, 33, 36, 37, 41, 43, 45, 46, 49, 52, 60, 66, 69, 70, 71, 72, 73, 90, 91, 101, 105, 120, 122, 128, 133, 143, 148, 149], "learn": [0, 43, 119, 144], "A": [0, 1, 2, 3, 8, 9, 11, 20, 21, 23, 24, 25, 26, 27, 29, 30, 32, 33, 36, 38, 39, 41, 43, 45, 46, 47, 52, 53, 55, 58, 65, 67, 68, 69, 70, 72, 73, 76, 78, 80, 81, 82, 83, 84, 86, 88, 89, 91, 93, 98, 101, 106, 113, 115, 118, 119, 122, 124, 130, 131, 132, 133, 140, 143, 144, 148, 149, 150, 151, 153, 156], "consist": [0, 12, 13, 15, 20, 23, 32, 39, 41, 43, 46, 49, 53, 67, 68, 69, 70, 73, 88, 90, 91, 99, 101, 108, 113, 120, 124, 125, 128, 139, 142, 143, 144, 148, 149, 153], "number": [0, 2, 3, 7, 9, 10, 13, 14, 15, 16, 17, 18, 20, 21, 22, 24, 25, 28, 29, 31, 33, 34, 36, 38, 41, 42, 43, 47, 52, 55, 60, 62, 66, 71, 72, 75, 76, 80, 82, 86, 88, 89, 90, 91, 94, 97, 98, 99, 100, 101, 105, 106, 111, 113, 115, 117, 120, 122, 123, 124, 125, 128, 133, 139, 140, 141, 142, 143, 144, 148, 150, 151, 153, 154, 156], "which": [0, 3, 5, 8, 11, 12, 14, 15, 16, 17, 19, 20, 21, 24, 25, 27, 28, 31, 33, 36, 39, 42, 43, 45, 46, 47, 49, 50, 51, 52, 53, 55, 60, 61, 63, 65, 66, 69, 70, 71, 72, 73, 74, 75, 76, 82, 84, 89, 90, 91, 92, 94, 96, 100, 101, 102, 103, 106, 108, 109, 111, 113, 117, 120, 122, 123, 124, 126, 129, 130, 131, 132, 133, 136, 139, 141, 142, 143, 144, 147, 148, 149, 152, 153, 154, 156, 157, 159], "execut": [0, 62], "ani": [0, 1, 3, 4, 11, 13, 16, 20, 21, 28, 40, 42, 46, 47, 55, 73, 82, 89, 91, 122, 124, 128, 133, 136, 137, 139, 143, 144, 145, 146, 149, 150, 154], "order": [0, 2, 3, 5, 7, 8, 15, 18, 19, 21, 22, 25, 29, 32, 33, 35, 39, 40, 42, 43, 45, 47, 48, 50, 52, 55, 60, 61, 64, 66, 67, 69, 70, 72, 73, 74, 75, 83, 88, 89, 90, 91, 94, 96, 99, 100, 101, 106, 111, 113, 117, 122, 129, 130, 133, 136, 139, 142, 143, 144, 156, 157], "most": [0, 3, 4, 5, 17, 18, 19, 20, 21, 33, 42, 44, 45, 47, 48, 55, 74, 84, 89, 91, 96, 98, 99, 101, 104, 108, 109, 111, 120, 122, 139, 141, 143, 144, 145, 147, 149, 150, 153], "relev": [0, 91, 98, 100, 133, 139, 143, 144, 153], "being": [0, 3, 5, 7, 12, 19, 21, 25, 28, 46, 47, 49, 55, 66, 74, 75, 82, 88, 89, 91, 99, 104, 108, 122, 124, 128, 142, 143, 144, 149], "where": [0, 3, 4, 5, 7, 8, 10, 14, 15, 16, 17, 18, 19, 20, 21, 22, 24, 25, 26, 27, 28, 29, 30, 31, 33, 36, 38, 39, 40, 42, 45, 46, 47, 48, 49, 52, 55, 57, 58, 60, 61, 66, 70, 71, 72, 73, 74, 75, 76, 78, 80, 82, 83, 84, 88, 89, 90, 91, 92, 94, 96, 97, 98, 99, 100, 102, 105, 106, 111, 113, 117, 120, 122, 123, 125, 142, 143, 144, 145, 146, 148, 149, 150, 153, 155, 157], "write": [0, 3, 21, 24, 29, 39, 43, 46, 52, 60, 70, 80, 82, 94, 153, 154, 156], "text": [0, 3, 7, 8, 18, 19, 21, 46, 47, 49, 60, 61, 66, 71, 72, 100, 125, 154], "equat": [0, 3, 7, 8, 11, 14, 16, 20, 21, 22, 25, 29, 33, 36, 38, 40, 41, 43, 45, 46, 47, 50, 52, 55, 60, 61, 65, 66, 67, 68, 70, 71, 72, 73, 75, 78, 82, 83, 84, 89, 91, 94, 96, 98, 99, 104, 106, 108, 111, 115, 117, 130, 136, 150], "insert": [0, 46, 55], "hyperlink": 0, "more": [0, 3, 4, 5, 8, 12, 19, 20, 21, 30, 31, 33, 34, 39, 43, 45, 46, 47, 49, 52, 55, 61, 66, 69, 70, 72, 74, 75, 76, 80, 82, 89, 91, 98, 101, 102, 103, 104, 120, 122, 124, 128, 130, 131, 132, 136, 137, 139, 141, 142, 143, 144, 148, 149, 153, 156, 157, 159], "contain": [0, 3, 11, 13, 21, 33, 35, 39, 42, 43, 45, 46, 47, 49, 55, 56, 60, 64, 72, 74, 75, 78, 82, 90, 113, 120, 140, 142, 143, 147, 148, 149], "mark": [0, 42, 73, 129, 142, 143], "press": [0, 67], "shift": [0, 46, 47, 66, 69, 70, 72, 84, 120, 124, 141, 142, 143, 144, 148, 149, 150], "enter": [0, 40, 46, 82, 96], "run": [0, 3, 4, 6, 7, 11, 13, 14, 18, 21, 22, 24, 25, 26, 28, 33, 34, 36, 38, 39, 41, 43, 44, 47, 52, 53, 58, 59, 60, 62, 65, 66, 70, 72, 75, 82, 88, 90, 92, 97, 101, 102, 105, 106, 113, 115, 117, 124, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 145, 147, 148, 151, 153, 154, 156, 157, 159], "botton": 0, "top": [0, 20, 21, 43, 60, 62, 75, 91, 101, 124, 144], "For": [0, 3, 4, 7, 8, 11, 15, 16, 17, 18, 21, 22, 24, 25, 26, 27, 28, 29, 30, 31, 33, 38, 39, 43, 45, 46, 47, 49, 52, 55, 60, 61, 63, 66, 69, 70, 72, 73, 74, 75, 76, 78, 82, 84, 86, 89, 90, 91, 96, 97, 98, 99, 100, 101, 102, 106, 108, 111, 113, 117, 119, 120, 122, 124, 130, 131, 133, 139, 141, 142, 143, 144, 148, 149, 150, 153, 155, 156], "thi": [0, 1, 3, 4, 5, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, 23, 24, 25, 26, 27, 28, 29, 30, 31, 32, 33, 35, 36, 37, 38, 39, 40, 42, 43, 45, 46, 47, 49, 50, 51, 52, 53, 54, 55, 56, 57, 60, 61, 62, 63, 64, 65, 66, 69, 70, 71, 72, 73, 74, 75, 76, 78, 80, 82, 83, 84, 86, 88, 89, 90, 91, 92, 93, 94, 96, 97, 98, 99, 100, 101, 102, 103, 104, 105, 106, 108, 109, 111, 113, 115, 117, 120, 121, 122, 123, 124, 125, 126, 128, 129, 130, 131, 133, 136, 137, 139, 140, 141, 142, 143, 144, 146, 147, 148, 149, 150, 151, 152, 153, 154, 155, 156, 157, 158, 159], "format": [0, 3, 14, 17, 33, 38, 47, 62, 65, 124, 125, 136, 142, 144, 151, 153, 156], "also": [0, 1, 3, 7, 11, 14, 15, 18, 19, 20, 21, 24, 26, 27, 29, 33, 36, 38, 43, 44, 46, 47, 49, 52, 55, 58, 60, 61, 64, 65, 69, 70, 71, 72, 73, 74, 75, 76, 82, 83, 88, 89, 90, 91, 92, 94, 96, 97, 98, 101, 102, 105, 108, 111, 113, 115, 117, 120, 122, 123, 124, 125, 129, 130, 133, 141, 143, 144, 147, 149, 150, 156, 157], "ctrl": 0, "onli": [0, 3, 4, 6, 11, 14, 16, 19, 20, 21, 22, 25, 29, 30, 33, 40, 42, 43, 46, 47, 49, 53, 55, 59, 60, 64, 65, 69, 70, 71, 72, 73, 74, 75, 80, 82, 84, 89, 90, 91, 92, 96, 97, 98, 100, 101, 102, 105, 106, 113, 122, 124, 130, 132, 137, 142, 143, 144, 147, 149, 151, 154, 156], "while": [0, 3, 18, 20, 21, 31, 45, 46, 47, 48, 49, 55, 60, 61, 64, 66, 70, 72, 73, 75, 82, 90, 101, 102, 109, 111, 120, 122, 123, 124, 129, 130, 132, 143, 144, 145, 153], "select": [0, 4, 13, 33, 42, 43, 47, 52, 55, 58, 92, 94, 100, 103, 105, 117, 131, 136, 137, 144, 152, 153, 154, 156, 157], "next": [0, 3, 14, 21, 27, 38, 39, 43, 49, 55, 57, 60, 66, 72, 75, 84, 89, 96, 101, 102, 105, 125, 139, 143, 144, 153], "from": [0, 1, 3, 4, 5, 6, 7, 8, 10, 11, 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, 24, 25, 26, 27, 28, 29, 31, 33, 36, 39, 41, 42, 43, 45, 46, 47, 49, 53, 54, 55, 56, 58, 59, 60, 61, 62, 65, 66, 67, 69, 70, 72, 73, 74, 75, 76, 80, 82, 83, 84, 86, 88, 89, 90, 91, 92, 94, 96, 97, 98, 99, 100, 101, 102, 103, 104, 105, 108, 111, 113, 117, 120, 122, 123, 124, 125, 130, 131, 132, 136, 137, 139, 141, 142, 143, 145, 146, 147, 149, 150, 151, 153, 154, 156, 157, 158, 159], "save": [0, 14, 42, 47, 52, 60, 75, 96, 105, 115, 120, 131, 133, 143, 153, 154, 156, 157], "memori": [0, 3, 17, 20, 43, 71, 72, 76, 89, 90, 98, 101, 120, 124, 148], "so": [0, 1, 3, 7, 8, 11, 14, 16, 20, 21, 22, 24, 30, 33, 36, 41, 42, 43, 46, 47, 49, 52, 55, 59, 61, 65, 66, 70, 71, 72, 74, 82, 84, 89, 90, 91, 92, 94, 97, 101, 102, 103, 113, 120, 122, 124, 133, 142, 143, 144, 147, 149, 150, 154], "good": [0, 14, 20, 21, 39, 43, 47, 52, 54, 60, 78, 91, 98, 122, 124, 128, 142, 143, 144, 149], "idea": [0, 3, 16, 19, 20, 21, 43, 52, 56, 64, 120, 144], "separ": [0, 3, 8, 11, 16, 20, 21, 22, 24, 25, 26, 27, 28, 30, 31, 33, 41, 45, 47, 66, 67, 68, 88, 99, 100, 101, 102, 104, 105, 111, 113, 129, 142, 143, 144, 147], "workflow": [0, 21, 43, 139, 141], "sever": [0, 3, 11, 13, 14, 16, 17, 19, 21, 26, 35, 42, 45, 47, 52, 53, 54, 60, 80, 82, 89, 91, 96, 99, 101, 103, 105, 111, 122, 124, 131, 133, 144, 149, 150], "block": [0, 14, 15, 17, 21, 25, 28, 33, 43, 46, 49, 69, 70, 72, 81, 86, 97, 106, 113, 115, 147], "e": [0, 1, 3, 4, 6, 7, 8, 10, 11, 13, 14, 15, 16, 19, 20, 21, 22, 25, 26, 27, 30, 31, 33, 35, 36, 38, 39, 40, 42, 43, 45, 46, 47, 48, 49, 50, 52, 53, 55, 58, 59, 60, 61, 62, 64, 66, 67, 69, 70, 71, 72, 73, 75, 76, 78, 80, 82, 83, 84, 86, 88, 90, 91, 94, 96, 97, 98, 99, 100, 101, 102, 105, 106, 111, 113, 115, 120, 122, 124, 125, 129, 130, 131, 132, 133, 139, 141, 142, 143, 144, 145, 148, 149, 150, 151, 153, 156], "g": [0, 1, 3, 6, 7, 8, 11, 14, 15, 17, 18, 21, 22, 25, 26, 38, 39, 42, 45, 46, 47, 49, 52, 53, 59, 60, 64, 65, 67, 69, 73, 82, 86, 91, 94, 99, 100, 106, 108, 111, 113, 117, 122, 124, 125, 131, 133, 139, 141, 142, 143, 144, 146, 148, 149, 150, 151, 153], "heavi": [0, 89, 91], "post": [0, 42, 100, 144], "process": [0, 3, 19, 21, 43, 47, 55, 57, 59, 60, 67, 69, 72, 73, 74, 82, 89, 91, 99, 102, 105, 109, 111, 117, 123, 128, 129, 130, 132, 140, 141, 143, 144, 148, 149], "anoth": [0, 11, 18, 20, 22, 25, 33, 43, 45, 46, 47, 49, 52, 60, 65, 71, 72, 73, 74, 99, 111, 120, 123, 129, 142, 153], "The": [0, 1, 4, 5, 6, 7, 8, 10, 11, 12, 13, 14, 15, 16, 17, 18, 19, 20, 24, 25, 26, 27, 28, 29, 30, 31, 33, 35, 36, 38, 39, 40, 41, 42, 43, 45, 46, 47, 49, 50, 53, 55, 57, 59, 60, 61, 62, 64, 65, 66, 67, 68, 69, 71, 72, 73, 74, 75, 76, 80, 81, 82, 83, 84, 86, 88, 89, 90, 91, 92, 93, 94, 96, 97, 98, 99, 100, 101, 102, 103, 104, 105, 106, 108, 111, 113, 115, 117, 118, 120, 122, 123, 124, 125, 128, 129, 130, 132, 133, 134, 136, 137, 139, 141, 142, 143, 145, 147, 148, 149, 150, 151, 152, 153, 154, 157, 158, 159], "scroll": 0, "down": [0, 13, 42, 49, 73, 80, 102, 125, 153], "window": [0, 20, 90, 101, 120, 124, 144], "edit": [0, 67], "doubl": [0, 3, 6, 7, 11, 21, 22, 26, 59, 67, 68, 69, 71, 72, 75, 76, 78, 120, 125, 133, 142, 144, 147, 149, 153, 157], "click": [0, 133], "chang": [0, 3, 11, 14, 18, 20, 21, 30, 33, 38, 39, 42, 45, 46, 47, 49, 61, 62, 70, 75, 76, 83, 84, 88, 89, 90, 91, 92, 97, 98, 101, 102, 108, 111, 113, 120, 124, 125, 126, 130, 131, 132, 136, 137, 141, 143, 144, 145, 148, 149, 153, 154, 157], "plain": 0, "lightweight": 0, "languag": [0, 43], "creat": [0, 3, 4, 22, 26, 29, 33, 39, 42, 47, 52, 55, 60, 65, 66, 69, 73, 97, 101, 105, 113, 122, 131, 132, 137, 140, 141, 142, 143, 144, 145, 148, 154, 156, 157, 159], "syntax": 0, "includ": [0, 3, 7, 21, 26, 27, 29, 30, 31, 33, 38, 40, 42, 43, 46, 47, 49, 52, 54, 55, 60, 61, 65, 66, 67, 68, 69, 72, 74, 76, 82, 88, 89, 90, 91, 97, 98, 99, 100, 101, 104, 106, 111, 120, 122, 124, 125, 128, 133, 140, 141, 142, 144, 147, 149, 150, 151, 152, 158], "head": [0, 67], "1": [0, 2, 3, 4, 6, 7, 8, 10, 11, 12, 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, 24, 25, 26, 27, 28, 29, 30, 31, 33, 34, 36, 38, 39, 41, 44, 45, 46, 47, 49, 52, 55, 58, 59, 60, 61, 62, 65, 66, 67, 69, 71, 72, 73, 75, 76, 78, 80, 81, 82, 83, 84, 86, 88, 89, 90, 91, 92, 94, 96, 97, 98, 99, 100, 101, 102, 105, 106, 108, 111, 113, 115, 117, 120, 122, 123, 124, 125, 126, 130, 131, 132, 133, 136, 137, 139, 141, 142, 143, 144, 145, 146, 148, 149, 150, 151, 153, 154, 156, 157, 159], "2": [0, 2, 3, 4, 7, 8, 10, 11, 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, 24, 25, 26, 27, 28, 29, 30, 31, 33, 34, 36, 38, 39, 41, 43, 44, 45, 46, 47, 49, 52, 55, 58, 59, 60, 61, 62, 65, 66, 67, 68, 69, 71, 73, 74, 75, 76, 78, 80, 81, 82, 83, 84, 86, 88, 89, 90, 91, 92, 94, 96, 97, 98, 99, 100, 101, 102, 105, 106, 108, 111, 113, 115, 117, 120, 122, 124, 125, 126, 128, 130, 131, 132, 133, 136, 139, 141, 142, 143, 144, 145, 146, 148, 149, 150, 151, 153, 156, 157, 159], "3": [0, 2, 3, 4, 6, 7, 8, 10, 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, 24, 25, 26, 27, 28, 29, 30, 31, 33, 34, 36, 38, 39, 41, 43, 44, 46, 47, 52, 55, 58, 59, 60, 61, 62, 65, 67, 72, 75, 76, 81, 82, 83, 84, 86, 89, 90, 91, 92, 94, 96, 98, 100, 101, 105, 106, 111, 113, 117, 120, 122, 123, 124, 125, 126, 128, 130, 131, 132, 133, 136, 139, 141, 142, 143, 144, 145, 147, 148, 149, 150, 151, 153, 156, 157, 159], "4": [0, 3, 4, 7, 8, 10, 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, 24, 25, 26, 27, 28, 31, 33, 34, 36, 38, 39, 41, 44, 46, 47, 52, 55, 58, 59, 60, 61, 62, 65, 66, 67, 69, 70, 71, 72, 75, 76, 81, 82, 83, 84, 86, 89, 90, 91, 92, 94, 97, 98, 99, 100, 101, 102, 105, 106, 113, 120, 122, 123, 124, 125, 130, 131, 132, 133, 136, 142, 143, 144, 145, 148, 150, 151, 153, 156, 157], "level": [0, 3, 4, 6, 7, 8, 18, 20, 21, 28, 31, 33, 34, 36, 38, 41, 43, 46, 47, 49, 50, 52, 67, 69, 70, 72, 73, 75, 76, 89, 92, 93, 98, 100, 101, 102, 103, 105, 120, 124, 125, 128, 129, 132, 137, 139, 141, 143, 144, 145, 148, 149, 153], "visibl": [0, 75, 103, 120, 123, 124, 129, 132], "right": [0, 4, 7, 8, 11, 16, 19, 20, 21, 22, 25, 26, 28, 29, 45, 46, 47, 49, 52, 55, 60, 61, 65, 70, 71, 72, 73, 75, 76, 78, 80, 82, 83, 84, 86, 89, 90, 97, 99, 100, 102, 106, 108, 111, 113, 117, 130, 133, 141, 143, 144, 150, 151, 157, 159], "bold": 0, "ital": 0, "have": [0, 3, 5, 7, 8, 10, 11, 15, 17, 19, 20, 21, 22, 24, 25, 28, 29, 30, 31, 33, 36, 38, 42, 43, 45, 46, 47, 49, 52, 60, 61, 65, 66, 69, 70, 71, 72, 74, 75, 76, 82, 86, 88, 89, 90, 91, 92, 94, 97, 98, 99, 100, 101, 102, 103, 105, 106, 113, 119, 120, 122, 124, 130, 131, 132, 133, 139, 141, 142, 143, 144, 148, 149, 150, 153, 154, 156], "line": [0, 8, 11, 21, 28, 42, 43, 60, 70, 73, 125, 133, 142, 143, 144, 149, 151, 153, 154, 156, 159], "break": [0, 7, 14, 20, 21, 39, 43, 47, 92, 122, 125, 143, 153, 154, 156], "like": [0, 3, 5, 17, 19, 20, 21, 45, 46, 47, 65, 69, 71, 75, 82, 92, 101, 120, 128, 131, 143, 144, 149, 154, 156], "subject": [0, 3, 43, 74, 78, 82, 88, 147], "new": [0, 3, 5, 14, 19, 33, 42, 43, 46, 47, 52, 53, 55, 60, 67, 73, 106, 131, 144, 148, 153], "link": [0, 3, 20, 39, 42, 43, 59, 62, 65, 67, 70, 131, 132, 133, 136, 139, 157, 159], "wikipedia": [0, 133, 144], "http": [0, 1, 42, 43, 67, 133], "www": 0, "org": [0, 1, 43, 67, 133, 144], "written": [0, 16, 19, 21, 22, 25, 26, 28, 29, 31, 33, 43, 46, 49, 52, 54, 55, 70, 72, 73, 75, 88, 89, 97, 113, 120, 133, 137, 143, 150], "similar": [0, 3, 8, 20, 21, 33, 45, 46, 47, 52, 55, 61, 64, 67, 72, 76, 78, 89, 90, 92, 98, 124, 139, 142, 143, 147, 148, 149], "latex": 0, "overlin": [0, 8, 10, 15, 26, 31, 97], "f": [0, 2, 3, 4, 6, 7, 8, 10, 11, 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, 24, 25, 27, 33, 34, 36, 38, 39, 41, 42, 44, 46, 49, 55, 60, 62, 67, 70, 72, 73, 74, 75, 76, 78, 81, 82, 83, 84, 86, 88, 89, 91, 92, 94, 96, 98, 99, 100, 101, 102, 105, 111, 113, 117, 122, 123, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 146, 148, 150, 151, 153, 156, 157], "m": [0, 1, 8, 21, 25, 27, 29, 31, 36, 39, 40, 41, 55, 61, 66, 67, 70, 71, 72, 73, 76, 80, 82, 84, 86, 89, 91, 98, 100, 102, 105, 106, 117, 130, 141, 148, 150], "sentenc": 0, "img": [0, 120, 153, 157], "logo": 0, "png": [0, 120], "throughout": [0, 82, 144], "abov": [0, 3, 7, 15, 18, 20, 21, 33, 36, 40, 42, 46, 47, 49, 55, 60, 70, 71, 72, 73, 75, 76, 80, 82, 84, 89, 91, 92, 101, 105, 113, 115, 122, 124, 125, 141, 142, 143, 144, 148, 149, 150, 153], "should": [0, 3, 4, 26, 38, 42, 46, 47, 49, 55, 72, 76, 82, 98, 99, 101, 113, 124, 126, 128, 133, 139, 142, 143, 144, 148, 149], "cover": [0, 9, 18, 43, 150], "main": [0, 3, 21, 24, 27, 42, 43, 47, 55, 61, 96, 99, 101, 102, 122, 143, 144], "familiar": [0, 3, 52, 128], "found": [0, 3, 15, 19, 20, 21, 22, 34, 43, 46, 47, 55, 60, 68, 78, 94, 98, 100, 102, 103, 104, 105, 108, 122, 136, 139, 143, 144, 149], "fact": [0, 4, 16, 19, 20, 21, 27, 28, 46, 47, 49, 55, 70, 72, 74, 82, 88, 90, 98, 122, 143], "mai": [0, 3, 14, 19, 20, 27, 29, 42, 43, 46, 59, 74, 76, 80, 89, 92, 98, 99, 100, 101, 108, 111, 120, 133, 139, 142, 143, 144, 147, 148, 149], "lead": [0, 3, 5, 8, 20, 21, 27, 46, 47, 49, 50, 55, 62, 65, 69, 70, 71, 72, 75, 80, 84, 89, 90, 101, 106, 115, 142, 143, 144, 148, 151], "some": [0, 1, 3, 4, 6, 7, 11, 13, 16, 17, 18, 19, 21, 22, 24, 25, 26, 27, 33, 34, 36, 39, 41, 43, 44, 45, 46, 47, 49, 52, 54, 58, 59, 60, 62, 65, 67, 68, 69, 70, 71, 72, 74, 75, 81, 88, 89, 90, 91, 92, 101, 102, 103, 105, 113, 115, 120, 124, 128, 129, 130, 131, 132, 133, 136, 137, 139, 141, 142, 143, 144, 145, 147, 148, 149, 151, 153, 154, 156, 157, 159], "confus": [0, 3], "depend": [0, 3, 4, 7, 8, 12, 15, 16, 19, 20, 21, 22, 25, 27, 33, 38, 40, 41, 42, 43, 45, 46, 47, 49, 52, 61, 67, 70, 71, 73, 74, 75, 76, 80, 82, 84, 89, 90, 97, 98, 99, 101, 103, 105, 108, 111, 117, 120, 124, 128, 129, 130, 132, 141, 143, 144, 145, 148, 149, 153], "between": [0, 3, 4, 8, 11, 14, 15, 16, 17, 18, 19, 20, 21, 24, 26, 27, 29, 31, 33, 35, 36, 39, 43, 47, 51, 52, 55, 59, 65, 67, 69, 70, 72, 73, 74, 76, 78, 80, 82, 88, 89, 90, 91, 92, 98, 99, 100, 101, 102, 103, 106, 111, 113, 117, 120, 123, 124, 129, 130, 133, 136, 139, 141, 142, 143, 144, 146, 148, 149, 150, 153, 154], "make": [0, 3, 17, 20, 21, 33, 42, 43, 46, 47, 52, 54, 55, 60, 72, 74, 75, 89, 101, 120, 122, 124, 128, 133, 141, 143, 144, 147, 148, 149, 154, 156], "sure": [0, 3, 33, 42, 60, 120, 133], "defin": [0, 3, 4, 6, 7, 18, 19, 20, 21, 26, 27, 29, 33, 36, 37, 38, 39, 44, 45, 46, 49, 52, 58, 59, 60, 61, 62, 66, 70, 72, 75, 82, 83, 84, 88, 89, 91, 94, 98, 103, 106, 108, 111, 113, 117, 124, 130, 131, 142, 144, 150, 153, 154, 156, 157], "befor": [0, 14, 20, 21, 38, 55, 60, 65, 92, 99, 100, 103, 119, 131, 133, 141, 148], "thei": [0, 3, 16, 18, 19, 20, 21, 42, 43, 46, 47, 56, 58, 66, 69, 72, 74, 78, 82, 84, 88, 89, 90, 91, 101, 105, 108, 120, 122, 128, 131, 133, 143, 144, 147, 149, 151, 153], "practic": [0, 5, 6, 14, 16, 17, 18, 20, 22, 25, 31, 43, 46, 47, 55, 60, 61, 64, 67, 71, 72, 73, 80, 82, 83, 89, 99, 100, 101, 102, 104, 105, 108, 109, 120, 123, 128, 136, 139, 141, 143, 148, 149], "restart": [0, 13, 92, 125, 143], "all": [0, 3, 7, 11, 16, 18, 19, 21, 22, 25, 26, 29, 30, 33, 34, 39, 43, 44, 45, 46, 47, 49, 50, 52, 55, 61, 64, 65, 66, 68, 70, 72, 73, 74, 75, 76, 82, 89, 90, 91, 96, 97, 98, 99, 100, 101, 102, 105, 111, 113, 117, 122, 124, 125, 130, 131, 133, 139, 142, 143, 144, 148, 150, 154, 156], "regularli": 0, "when": [0, 3, 6, 8, 11, 15, 16, 21, 25, 31, 38, 42, 43, 46, 47, 52, 53, 55, 60, 70, 72, 73, 74, 78, 80, 82, 84, 89, 91, 92, 94, 98, 100, 102, 103, 111, 121, 126, 142, 143, 144, 148, 149], "problem": [0, 19, 20, 21, 42, 43, 45, 46, 47, 55, 67, 72, 89, 98, 99, 106, 111, 120, 148, 150, 153], "occur": [0, 21, 27, 33, 46, 69, 72, 73, 74, 89, 120, 123, 143, 144, 148], "As": [0, 3, 4, 11, 14, 17, 18, 19, 21, 27, 28, 29, 31, 33, 38, 39, 42, 43, 46, 47, 49, 55, 62, 65, 66, 70, 72, 74, 75, 76, 78, 82, 84, 88, 90, 91, 92, 96, 97, 98, 99, 100, 101, 106, 113, 120, 122, 123, 124, 128, 130, 132, 133, 139, 142, 143, 144, 148, 149, 151, 153, 156, 157], "def": [0, 3, 4, 7, 14, 20, 21, 27, 29, 33, 38, 39, 47, 52, 60, 62, 65, 70, 81, 83, 86, 88, 105, 106, 113, 120, 124, 125, 130, 131, 132, 136, 143, 144, 148, 151, 153, 154, 156], "sum_numb": 0, "b": [0, 3, 7, 8, 14, 17, 18, 20, 21, 22, 25, 27, 30, 33, 38, 45, 46, 52, 66, 67, 69, 70, 72, 73, 80, 81, 82, 86, 88, 91, 96, 99, 100, 106, 113, 115, 122, 129, 132, 142, 143], "return": [0, 3, 4, 7, 13, 14, 20, 21, 27, 29, 33, 38, 39, 43, 47, 52, 58, 60, 62, 65, 70, 72, 81, 83, 86, 88, 94, 98, 106, 113, 120, 124, 125, 130, 131, 132, 133, 136, 142, 143, 144, 148, 150, 151, 154, 156], "0": [0, 1, 2, 3, 4, 6, 7, 8, 10, 11, 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, 24, 25, 26, 27, 28, 29, 31, 33, 34, 36, 38, 39, 41, 44, 45, 46, 47, 49, 52, 58, 59, 60, 61, 62, 65, 66, 72, 73, 75, 76, 78, 81, 82, 83, 84, 86, 88, 89, 90, 91, 92, 94, 96, 97, 98, 99, 100, 101, 102, 105, 106, 111, 113, 115, 117, 120, 122, 123, 124, 125, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 145, 146, 148, 149, 150, 151, 153, 154, 156, 157, 159], "assign": [0, 47, 113, 125, 142, 144, 145, 153], "variabl": [0, 16, 20, 25, 26, 33, 43, 45, 46, 47, 49, 60, 88, 91, 92, 143, 148, 153], "print": [0, 2, 3, 4, 6, 7, 10, 13, 14, 17, 18, 20, 21, 22, 24, 25, 26, 27, 28, 29, 33, 34, 36, 38, 39, 41, 44, 47, 52, 60, 62, 65, 70, 72, 75, 76, 78, 83, 86, 88, 89, 90, 94, 97, 98, 99, 100, 101, 102, 105, 113, 115, 120, 122, 124, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 145, 148, 150, 151, 153, 156], "n_sum": 0, "note": [0, 3, 7, 10, 11, 14, 15, 17, 18, 20, 21, 22, 25, 27, 33, 34, 38, 39, 41, 46, 47, 49, 54, 55, 62, 65, 67, 71, 72, 74, 76, 80, 82, 83, 86, 88, 91, 94, 96, 97, 98, 100, 101, 108, 111, 113, 115, 122, 124, 125, 128, 143, 144, 147, 148, 149, 154, 156], "automat": [0, 100, 122], "an": [0, 3, 4, 5, 6, 7, 8, 9, 10, 11, 12, 14, 15, 16, 17, 18, 19, 20, 21, 22, 23, 24, 25, 27, 28, 29, 31, 32, 33, 35, 36, 38, 39, 41, 42, 43, 44, 45, 46, 47, 49, 50, 51, 52, 55, 56, 58, 60, 61, 62, 67, 68, 69, 71, 72, 73, 74, 75, 76, 78, 80, 82, 83, 84, 88, 89, 91, 94, 96, 97, 98, 99, 100, 101, 102, 105, 111, 113, 120, 122, 123, 124, 125, 129, 130, 133, 137, 141, 142, 143, 144, 147, 148, 149, 151, 153, 154, 156, 157, 159], "integ": [0, 3, 18, 82, 100, 120], "float": [0, 33, 88, 99, 100, 156], "ad": [0, 17, 19, 33, 36, 38, 39, 41, 42, 46, 47, 53, 55, 72, 75, 89, 90, 101, 124, 127, 133, 142, 143, 144, 145, 146, 147, 148, 149, 156], "togeth": [0, 3, 9, 43, 45, 46, 47, 55, 66, 72, 105, 122, 144], "convert": [0, 40, 47, 52, 55, 61, 66, 71, 124, 136, 142, 144], "advanc": [0, 47, 67], "add": [0, 3, 7, 8, 21, 33, 36, 39, 43, 52, 60, 65, 70, 91, 92, 101, 124, 130, 131, 132, 133, 142, 146, 149, 156], "comment": [0, 1, 156], "sum": [0, 3, 16, 21, 22, 24, 25, 26, 27, 30, 33, 34, 36, 38, 39, 41, 46, 47, 49, 52, 55, 66, 70, 72, 81, 82, 88, 89, 99, 100, 108, 142, 151, 153], "tweak": 0, "posit": [0, 3, 4, 8, 16, 20, 26, 28, 29, 31, 33, 34, 36, 39, 45, 46, 47, 49, 52, 55, 60, 64, 70, 78, 83, 84, 88, 91, 98, 100, 113, 129, 130, 142, 143, 144, 153, 157, 159], "decim": 0, "notat": [0, 15, 17, 21, 22, 25, 26, 29, 33, 43, 46, 49, 70, 72, 86, 89, 91, 100, 113, 122, 133, 141], "2d": [0, 7, 14, 21, 26, 33, 39, 44, 60, 70, 81, 120, 133], "5": [0, 3, 4, 7, 8, 10, 12, 14, 17, 18, 20, 21, 22, 24, 27, 31, 33, 34, 36, 38, 41, 44, 45, 47, 52, 59, 60, 62, 65, 66, 67, 70, 72, 75, 76, 81, 82, 83, 86, 88, 89, 90, 91, 92, 96, 98, 99, 100, 101, 105, 111, 113, 115, 120, 122, 124, 125, 130, 131, 132, 136, 139, 142, 143, 144, 145, 148, 150, 151, 153, 156, 157], "4f": [0, 38, 76, 81, 89, 98, 101, 102, 105, 139, 150], "2e": [0, 7, 14, 18, 20, 21, 39, 75, 81, 90, 101, 120, 124], "0000": [0, 20, 21, 38, 76, 81, 89, 98, 102, 105, 120, 124, 125, 144, 148, 153, 156], "00e": [0, 72], "00": [0, 3, 7, 14, 20, 44, 65, 70, 72, 75, 76, 90, 100, 101, 105, 113, 120, 122, 124, 125, 131, 143, 148], "If": [0, 1, 3, 4, 6, 10, 11, 20, 21, 33, 43, 45, 46, 47, 49, 55, 60, 82, 91, 92, 94, 97, 100, 111, 120, 122, 125, 128, 129, 142, 143, 144, 149, 154, 156], "jupyterlab_code_formatt": 0, "packag": [0, 3, 20, 21, 42, 43, 54, 67, 100, 120, 125, 133, 143, 148, 157], "instal": [0, 3, 4, 6, 7, 11, 13, 14, 18, 22, 24, 25, 26, 34, 36, 39, 41, 43, 44, 47, 52, 58, 59, 62, 65, 70, 72, 75, 81, 88, 90, 92, 101, 102, 105, 113, 115, 124, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 151, 153, 154, 156, 157, 159], "environ": [0, 33, 39, 41, 43, 52, 67, 69, 92, 141, 142, 144, 147, 148, 149, 153], "command": [0, 33, 42, 43, 131], "clock": [0, 43], "symbol": [0, 31, 91, 133, 150], "instanc": [0, 22, 46, 76, 82, 84, 98, 124], "take": [0, 3, 6, 7, 10, 11, 15, 17, 19, 21, 22, 25, 26, 28, 29, 31, 33, 43, 46, 47, 49, 55, 60, 61, 64, 70, 76, 80, 82, 83, 89, 91, 99, 100, 113, 123, 124, 126, 133, 136, 144], "follow": [0, 1, 3, 4, 7, 8, 11, 14, 15, 16, 17, 18, 19, 20, 21, 24, 29, 33, 36, 38, 39, 42, 46, 49, 50, 52, 55, 60, 61, 65, 66, 68, 70, 71, 72, 73, 78, 82, 83, 84, 88, 91, 94, 96, 97, 99, 100, 101, 102, 103, 111, 117, 120, 122, 123, 128, 131, 133, 141, 143, 144, 148, 149], "import": [0, 2, 3, 4, 6, 7, 8, 10, 11, 13, 14, 17, 18, 19, 20, 21, 22, 24, 25, 26, 27, 28, 29, 31, 33, 34, 36, 38, 39, 41, 42, 43, 44, 45, 47, 48, 52, 58, 59, 60, 62, 64, 69, 70, 72, 74, 75, 76, 78, 82, 83, 86, 88, 89, 90, 91, 92, 94, 96, 97, 98, 99, 100, 101, 102, 105, 106, 108, 113, 115, 120, 122, 124, 125, 130, 131, 132, 133, 136, 137, 139, 143, 144, 145, 147, 148, 150, 151, 153, 154, 156, 157, 159], "numpi": [0, 3, 4, 6, 7, 8, 10, 13, 14, 17, 18, 20, 21, 22, 24, 25, 26, 27, 28, 29, 31, 33, 38, 39, 43, 44, 47, 52, 58, 60, 62, 65, 70, 72, 75, 78, 81, 83, 86, 88, 92, 94, 96, 97, 99, 100, 101, 105, 106, 113, 115, 120, 124, 125, 130, 131, 132, 136, 139, 143, 144, 145, 148, 151, 153, 156, 157], "matplotlib": [0, 2, 3, 4, 7, 8, 14, 18, 20, 21, 27, 28, 31, 33, 47, 52, 58, 59, 60, 62, 70, 75, 81, 92, 96, 99, 100, 101, 105, 106, 113, 120, 124, 125, 130, 131, 132, 143, 144, 145, 148, 151, 156, 157], "pyplot": [0, 2, 3, 4, 7, 8, 14, 18, 20, 21, 27, 28, 31, 33, 47, 52, 58, 59, 60, 62, 70, 75, 81, 92, 99, 100, 101, 105, 106, 113, 120, 124, 125, 130, 131, 132, 143, 144, 145, 148, 151, 156, 157], "plt": [0, 2, 3, 4, 7, 8, 14, 18, 20, 21, 27, 28, 31, 33, 47, 52, 58, 59, 60, 62, 70, 75, 81, 92, 96, 99, 100, 101, 105, 106, 113, 120, 124, 125, 130, 131, 132, 142, 143, 144, 145, 148, 151, 156, 157], "veloxchem": [0, 2, 3, 4, 5, 6, 7, 8, 10, 12, 14, 17, 18, 20, 21, 22, 24, 25, 26, 28, 33, 34, 36, 38, 39, 41, 42, 44, 46, 47, 52, 58, 59, 60, 62, 65, 70, 72, 75, 78, 81, 83, 86, 90, 92, 94, 96, 101, 102, 105, 113, 115, 120, 122, 124, 125, 130, 131, 132, 133, 136, 137, 139, 143, 144, 145, 148, 150, 151, 153, 156, 157, 159], "vlx": [0, 2, 3, 4, 6, 7, 8, 10, 13, 14, 17, 18, 20, 21, 22, 24, 25, 26, 28, 33, 34, 36, 38, 39, 41, 42, 44, 47, 52, 58, 59, 60, 62, 65, 70, 72, 75, 76, 78, 81, 83, 86, 88, 89, 90, 92, 94, 96, 98, 100, 101, 102, 105, 106, 113, 115, 120, 122, 124, 125, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 145, 148, 151, 153, 156, 157, 159], "call_funt": 0, "argument1": 0, "argument2": 0, "argument3": 0, "argument4": 0, "argument5": 0, "And": [0, 10, 26, 42, 43, 62, 86, 94, 111, 125, 137, 144], "reformat": 0, "One": [0, 3, 9, 20, 21, 47, 69, 70, 72, 73, 82, 91, 120, 124, 144, 148, 153], "advantag": [0, 3, 17, 21, 46, 47, 50, 52, 72, 124, 142], "extens": [0, 3, 4, 6, 7, 11, 13, 14, 18, 21, 22, 24, 25, 26, 34, 36, 39, 41, 43, 44, 47, 52, 58, 59, 62, 65, 70, 72, 75, 81, 88, 90, 92, 101, 102, 105, 113, 115, 124, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 151, 153, 154, 156, 157, 159], "avail": [0, 5, 17, 18, 26, 28, 42, 43, 47, 49, 54, 59, 68, 72, 76, 89, 98, 100, 113, 122, 143, 144, 145, 148, 149, 150, 157, 159], "modul": [0, 4, 7, 14, 21, 22, 38, 42, 43, 62, 66, 105, 140, 144, 148, 154, 156, 157], "larg": [0, 3, 4, 5, 8, 17, 18, 20, 21, 34, 42, 43, 47, 53, 60, 67, 68, 69, 71, 89, 98, 106, 113, 126, 128, 139, 141, 142, 143, 144, 148, 149, 150], "collect": [0, 10, 15, 22, 25, 26, 27, 29, 52, 72, 82, 94, 96, 102, 111, 113, 130, 150], "mathemat": [0, 60, 67, 82], "librari": [0, 10, 43, 76, 89, 98, 148, 159], "scipi": [0, 7, 8, 10, 14, 21, 39, 47, 58, 97, 99, 113, 124, 144, 150], "scientif": [0, 42, 43], "technic": [0, 3, 99, 108, 111, 143], "comput": [0, 1, 2, 3, 4, 6, 7, 8, 10, 13, 14, 16, 17, 18, 20, 21, 22, 24, 25, 26, 28, 33, 34, 36, 38, 39, 41, 43, 44, 45, 46, 47, 52, 53, 54, 58, 59, 60, 65, 67, 68, 69, 70, 71, 72, 75, 76, 78, 80, 83, 84, 86, 88, 89, 90, 91, 92, 94, 96, 98, 99, 100, 101, 102, 103, 104, 105, 106, 111, 113, 115, 117, 120, 122, 124, 125, 126, 128, 130, 131, 132, 136, 137, 139, 141, 142, 143, 144, 145, 148, 149, 151, 153, 157], "program": [0, 5, 10, 17, 21, 26, 38, 42, 43, 46, 54, 67, 86, 88, 101, 105], "py3dmol": [0, 18, 39, 47, 59, 60, 62, 65, 70, 81, 90, 92, 113, 115, 124, 130, 131, 132, 133, 136, 137, 139, 144, 154, 156, 157, 159], "molecul": [0, 2, 3, 4, 5, 6, 7, 8, 10, 11, 14, 17, 18, 19, 20, 21, 22, 24, 25, 28, 33, 34, 36, 37, 38, 39, 41, 43, 44, 45, 47, 49, 52, 58, 61, 62, 63, 66, 67, 68, 69, 70, 72, 74, 75, 76, 78, 82, 83, 84, 86, 88, 89, 90, 91, 92, 94, 96, 98, 99, 100, 101, 102, 105, 106, 111, 113, 115, 120, 122, 124, 125, 126, 128, 129, 130, 131, 132, 133, 134, 136, 137, 139, 142, 143, 144, 145, 148, 149, 151, 153, 156, 157, 159], "These": [0, 3, 18, 20, 21, 45, 46, 55, 58, 60, 62, 64, 69, 70, 72, 80, 82, 83, 90, 100, 103, 113, 122, 123, 128, 130, 132, 133, 139, 143, 144, 147, 149, 151, 153, 157, 159], "load": [0, 3, 4, 6, 7, 11, 13, 14, 18, 22, 24, 25, 26, 34, 36, 39, 41, 44, 47, 52, 58, 59, 62, 65, 70, 72, 75, 81, 88, 90, 92, 101, 102, 105, 113, 115, 124, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 148, 151, 153, 154, 156, 157, 159], "whole": [0, 55, 117], "given": [0, 3, 4, 8, 9, 11, 12, 15, 16, 18, 21, 22, 25, 26, 27, 28, 29, 31, 33, 38, 39, 45, 46, 49, 52, 55, 58, 60, 61, 63, 66, 68, 70, 72, 76, 82, 83, 84, 88, 89, 91, 94, 98, 99, 100, 102, 103, 115, 117, 124, 133, 143, 144, 150], "alia": 0, "avoid": [0, 21, 29, 33, 41, 46, 49, 71, 90, 120, 139, 142, 143, 144, 148], "collis": [0, 55], "overwrit": 0, "specif": [0, 4, 8, 17, 20, 21, 29, 46, 47, 54, 60, 61, 69, 72, 74, 82, 90, 102, 103, 113, 117, 120, 124, 141, 143, 144, 148, 149, 153, 156], "requir": [0, 3, 4, 14, 15, 16, 17, 24, 36, 38, 41, 42, 43, 45, 46, 47, 49, 52, 55, 56, 60, 61, 62, 67, 70, 72, 76, 82, 97, 98, 101, 108, 111, 117, 128, 130, 142, 143, 144, 148, 149, 154, 156], "p3d": [0, 18, 47, 59, 60, 62, 65, 70, 81, 90, 113, 115, 124, 130, 131, 132, 133, 136, 137, 139, 144, 154, 156], "user": [0, 17, 21, 26, 38, 43, 72, 124, 154], "other": [0, 3, 4, 6, 7, 8, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 24, 25, 26, 27, 28, 29, 31, 33, 34, 36, 39, 41, 42, 44, 46, 47, 49, 52, 55, 56, 58, 59, 60, 61, 62, 64, 65, 70, 71, 72, 73, 74, 75, 76, 81, 82, 88, 89, 90, 91, 92, 98, 101, 102, 105, 113, 115, 120, 122, 124, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 148, 149, 150, 151, 153, 154, 156, 157, 159], "experienc": [0, 14, 43, 74, 98, 141, 143], "issu": [0, 1, 3, 5, 10, 19, 20, 21, 22, 42, 43, 60, 72, 101, 105, 106, 142, 143, 144, 148, 150], "properli": [0, 20, 124, 143, 149], "due": [0, 3, 5, 8, 10, 15, 16, 17, 19, 22, 27, 31, 33, 38, 39, 41, 46, 47, 55, 68, 69, 74, 75, 82, 88, 89, 90, 92, 98, 102, 111, 113, 120, 122, 141, 142, 143, 144], "openmp": [0, 42, 43], "conflict": 0, "resolv": [0, 67, 89, 100, 106, 113, 124, 141, 142, 143, 144, 151, 153], "temporari": [0, 42, 47], "solut": [0, 3, 15, 16, 19, 20, 22, 27, 38, 39, 42, 46, 49, 61, 67, 72, 86, 88, 89, 96, 99, 100, 108, 113, 150, 153], "describ": [0, 1, 3, 4, 5, 8, 12, 16, 19, 20, 21, 23, 26, 30, 31, 32, 35, 36, 37, 45, 46, 47, 49, 50, 53, 55, 61, 66, 68, 70, 72, 73, 74, 75, 76, 78, 80, 82, 84, 88, 89, 90, 91, 92, 93, 98, 99, 100, 101, 108, 111, 117, 121, 122, 124, 125, 132, 133, 141, 144, 145, 148, 149, 150, 153], "o": [0, 2, 3, 6, 7, 10, 13, 14, 17, 18, 20, 21, 22, 24, 25, 26, 28, 34, 36, 39, 41, 42, 44, 46, 47, 52, 55, 58, 59, 62, 67, 69, 70, 71, 72, 75, 76, 82, 83, 86, 89, 90, 91, 92, 96, 98, 101, 105, 106, 113, 120, 122, 124, 125, 130, 131, 132, 133, 136, 137, 139, 143, 144, 145, 148, 151, 153, 156, 157, 159], "kmp_duplicate_lib_ok": [0, 42], "true": [0, 2, 4, 7, 8, 10, 18, 19, 20, 26, 27, 28, 31, 38, 42, 44, 46, 47, 55, 58, 59, 62, 65, 70, 72, 78, 81, 90, 94, 96, 97, 99, 100, 105, 106, 120, 122, 131, 132, 144, 148, 153], "appropri": [0, 3, 46, 66, 74, 82, 91, 113, 143, 144], "valu": [0, 3, 4, 6, 7, 8, 10, 11, 15, 18, 19, 20, 29, 30, 31, 33, 38, 39, 46, 52, 55, 58, 60, 64, 65, 70, 72, 76, 82, 84, 86, 89, 94, 98, 99, 100, 111, 113, 117, 120, 122, 125, 143, 144, 148, 150, 154, 156, 157], "pi": [0, 3, 4, 7, 8, 11, 15, 16, 19, 20, 25, 29, 31, 36, 39, 41, 46, 47, 61, 66, 67, 70, 73, 82, 91, 92, 94, 96, 97, 100, 102, 105, 113, 120, 122, 124, 130, 131, 132, 142, 143, 144, 146, 150, 151, 156, 157], "141592653589793": 0, "move": [0, 11, 29, 42, 46, 47, 55, 60, 74, 82, 94, 111, 143, 144, 148], "system": [0, 3, 4, 6, 8, 9, 11, 12, 15, 16, 17, 18, 19, 20, 21, 22, 26, 27, 28, 29, 30, 33, 34, 35, 36, 38, 39, 41, 42, 43, 46, 47, 52, 53, 55, 60, 66, 67, 69, 71, 73, 74, 76, 78, 80, 82, 83, 84, 88, 89, 90, 91, 94, 96, 97, 98, 100, 101, 102, 103, 105, 108, 109, 111, 113, 120, 121, 122, 123, 128, 130, 141, 142, 144, 148, 149, 150, 153, 159], "consid": [0, 3, 6, 8, 15, 16, 17, 21, 22, 24, 25, 26, 27, 28, 29, 33, 34, 36, 37, 38, 39, 41, 46, 47, 49, 52, 53, 55, 61, 62, 70, 73, 74, 82, 89, 91, 96, 97, 100, 102, 103, 104, 106, 111, 113, 117, 124, 128, 131, 136, 137, 141, 143, 144, 145, 146, 147, 149, 150, 151, 153, 157], "water": [0, 3, 6, 10, 13, 14, 17, 18, 21, 22, 33, 47, 67, 70, 72, 75, 83, 90, 101, 106, 124, 126, 130, 143, 144, 145, 148, 151, 153, 157, 159], "repres": [0, 3, 7, 10, 12, 19, 20, 26, 28, 31, 33, 36, 41, 46, 47, 53, 55, 60, 65, 66, 70, 72, 73, 82, 91, 100, 102, 122, 123, 143, 144, 148, 153], "xyz": [0, 18, 39, 47, 59, 62, 65, 70, 90, 92, 105, 106, 130, 131, 132, 133, 134, 136, 137, 139, 148, 156, 159], "string": [0, 3, 28, 44, 47, 58, 59, 65, 100, 125, 131, 133, 134, 136, 139, 142], "atom": [0, 4, 6, 7, 8, 10, 13, 15, 16, 17, 18, 19, 20, 21, 28, 31, 33, 34, 35, 36, 37, 39, 41, 43, 45, 46, 47, 49, 52, 53, 55, 59, 61, 62, 66, 67, 69, 70, 76, 78, 82, 89, 91, 98, 99, 100, 105, 111, 120, 122, 124, 125, 130, 131, 133, 136, 139, 141, 143, 144, 145, 148, 149, 153, 156, 159], "coordin": [0, 4, 6, 8, 16, 17, 18, 25, 28, 30, 38, 39, 43, 46, 47, 48, 49, 55, 56, 60, 61, 64, 65, 67, 84, 91, 100, 102, 105, 120, 130, 131, 132, 133, 134, 137, 143, 150, 156, 157], "\u00e5ngstr\u00f6m": 0, "water_xyz": [0, 70, 143, 144, 145, 148, 151], "0000000000": [0, 13, 20, 39, 47, 70, 75, 90, 101, 106, 120, 124, 125, 143, 144, 145, 146, 148, 151, 153, 157], "1178336003": [0, 13, 47, 70, 75, 90, 101, 106, 124, 143, 144, 145, 148, 151, 157], "h": [0, 3, 4, 6, 7, 10, 11, 13, 14, 15, 16, 17, 18, 20, 21, 22, 25, 27, 29, 31, 34, 35, 36, 38, 39, 41, 45, 46, 47, 52, 58, 59, 60, 62, 65, 66, 67, 70, 72, 75, 76, 78, 80, 81, 83, 86, 88, 89, 90, 91, 92, 94, 96, 98, 99, 100, 101, 102, 105, 106, 111, 113, 115, 117, 120, 124, 125, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 145, 146, 148, 150, 151, 153, 156, 157, 159], "7595754146": [0, 13, 47, 70, 75, 90, 101, 106, 124, 143, 144, 145, 148, 151, 157], "4713344012": [0, 13, 47, 70, 75, 90, 101, 106, 124, 143, 144, 145, 148, 151, 157], "object": [0, 3, 11, 13, 26, 39, 47, 52, 59, 62, 70, 71, 113, 124, 125, 132, 133, 137, 139, 142, 143, 144, 145, 151, 153, 156, 157], "read_xyz_str": [0, 3, 6, 7, 8, 10, 13, 14, 17, 18, 21, 22, 24, 25, 26, 33, 34, 36, 39, 41, 44, 52, 58, 59, 65, 70, 72, 75, 76, 81, 83, 86, 88, 89, 90, 94, 96, 98, 101, 102, 105, 130, 131, 132, 136, 137, 139, 143, 144, 151, 156, 157, 159], "show": [0, 2, 3, 4, 6, 7, 8, 13, 14, 15, 18, 20, 21, 22, 26, 27, 28, 30, 31, 33, 39, 43, 44, 47, 52, 58, 59, 60, 62, 65, 69, 70, 75, 81, 88, 90, 91, 92, 96, 99, 100, 101, 105, 106, 113, 120, 124, 125, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 145, 148, 151, 153, 154, 156, 157, 159], "method": [0, 2, 3, 4, 5, 6, 8, 9, 12, 13, 14, 17, 18, 24, 26, 28, 32, 34, 35, 36, 38, 39, 41, 43, 44, 46, 49, 53, 55, 56, 58, 59, 64, 67, 68, 70, 75, 84, 86, 88, 94, 99, 101, 103, 104, 117, 124, 125, 126, 128, 133, 141, 142, 148, 153], "illustr": [0, 3, 4, 9, 11, 14, 16, 17, 18, 30, 38, 39, 43, 46, 53, 55, 56, 60, 65, 69, 72, 73, 76, 82, 83, 94, 96, 98, 100, 102, 105, 113, 115, 120, 121, 122, 123, 129, 133, 139, 140, 142, 143, 144, 148, 153, 155, 157, 159], "rotat": [0, 2, 11, 21, 39, 41, 43, 46, 47, 60, 61, 62, 63, 65, 67, 70, 74, 84, 88, 90, 92, 102, 103, 130, 132, 133, 142, 143, 157, 159], "zoom": [0, 59, 124, 144, 159], "jupyterlab": [0, 3, 4, 6, 7, 11, 13, 14, 18, 22, 24, 25, 26, 34, 36, 39, 41, 42, 44, 47, 52, 58, 59, 62, 65, 70, 72, 75, 81, 88, 90, 92, 101, 102, 105, 113, 115, 124, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 151, 153, 154, 156, 157, 159], "javascript": [0, 3, 4, 6, 7, 11, 13, 14, 18, 22, 24, 25, 26, 34, 36, 39, 41, 44, 47, 52, 58, 59, 62, 65, 70, 72, 75, 81, 88, 90, 92, 101, 102, 105, 113, 115, 124, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 151, 153, 154, 156, 157, 159], "fail": [0, 3, 4, 6, 7, 11, 13, 14, 18, 21, 22, 24, 25, 26, 34, 36, 39, 41, 42, 44, 47, 52, 58, 59, 62, 65, 70, 72, 75, 81, 88, 90, 92, 101, 102, 105, 113, 115, 124, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 151, 153, 154, 156, 157, 159], "reason": [0, 3, 4, 6, 7, 8, 11, 13, 14, 18, 20, 21, 22, 24, 25, 26, 27, 33, 34, 36, 39, 41, 44, 46, 47, 52, 55, 58, 59, 60, 62, 64, 65, 70, 72, 75, 81, 88, 90, 92, 94, 98, 101, 102, 105, 108, 113, 115, 120, 122, 124, 126, 128, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 146, 148, 149, 151, 153, 154, 156, 157, 159], "3dmol": [0, 3, 4, 6, 7, 11, 13, 14, 18, 22, 24, 25, 26, 34, 36, 39, 41, 44, 47, 52, 58, 59, 62, 65, 70, 72, 75, 81, 88, 90, 92, 101, 102, 105, 113, 115, 124, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 151, 153, 154, 156, 157, 159], "labextens": [0, 3, 4, 6, 7, 11, 13, 14, 18, 22, 24, 25, 26, 34, 36, 39, 41, 44, 47, 52, 58, 59, 62, 65, 70, 72, 75, 81, 88, 90, 92, 101, 102, 105, 113, 115, 124, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 151, 153, 154, 156, 157, 159], "jupyterlab_3dmol": [0, 3, 4, 6, 7, 11, 13, 14, 18, 22, 24, 25, 26, 34, 36, 39, 41, 44, 47, 52, 58, 59, 62, 65, 70, 72, 75, 81, 88, 90, 92, 101, 102, 105, 113, 115, 124, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 151, 153, 154, 156, 157, 159], "specifi": [0, 3, 4, 43, 46, 47, 91, 133, 144], "molecularbasi": [0, 2, 3, 4, 6, 7, 8, 10, 13, 14, 17, 18, 20, 21, 22, 24, 25, 26, 28, 33, 34, 36, 38, 39, 41, 47, 52, 65, 70, 72, 75, 76, 78, 81, 83, 86, 88, 89, 90, 92, 94, 96, 98, 100, 101, 102, 105, 106, 113, 115, 120, 122, 124, 130, 131, 132, 136, 137, 142, 143, 144, 145, 148, 151, 153, 157], "read": [0, 2, 3, 4, 6, 7, 8, 10, 13, 14, 17, 18, 19, 20, 21, 22, 24, 25, 26, 27, 28, 33, 34, 36, 38, 39, 41, 47, 52, 62, 65, 70, 72, 75, 76, 78, 81, 83, 86, 88, 89, 90, 92, 94, 96, 98, 100, 101, 102, 105, 106, 113, 115, 120, 122, 124, 125, 130, 131, 132, 133, 136, 137, 142, 143, 144, 145, 148, 151, 153, 154, 156, 157], "6": [0, 2, 3, 4, 6, 7, 8, 14, 17, 18, 20, 21, 22, 24, 26, 27, 31, 33, 34, 36, 38, 39, 41, 44, 45, 47, 52, 55, 58, 59, 60, 62, 65, 66, 70, 72, 75, 76, 81, 82, 83, 86, 88, 89, 90, 91, 92, 94, 96, 97, 98, 99, 100, 101, 102, 105, 106, 113, 115, 120, 122, 124, 125, 130, 131, 132, 136, 137, 139, 142, 143, 144, 145, 146, 148, 149, 150, 151, 153, 156, 157], "31g": [0, 3, 21, 22, 26, 34, 36, 38, 41, 47, 72, 75, 86, 90, 94, 101, 102, 105, 106, 113, 115, 124, 125, 131, 132, 142, 143, 144, 145, 146, 148, 149, 151, 153, 157], "ostream": [0, 2, 3, 4, 6, 7, 8, 10, 13, 14, 17, 18, 20, 21, 22, 24, 25, 26, 28, 33, 34, 36, 41, 44, 52, 58, 59, 72, 76, 78, 83, 86, 88, 89, 94, 96, 98, 102, 105, 115, 130, 131, 132, 136, 139, 144, 145, 153, 157], "none": [0, 2, 3, 4, 6, 7, 8, 10, 13, 14, 17, 18, 20, 21, 22, 24, 25, 26, 28, 33, 34, 36, 41, 52, 60, 76, 78, 83, 86, 88, 89, 94, 96, 98, 102, 105, 115, 124, 125, 130, 131, 132, 136, 143, 145, 153, 157], "about": [0, 11, 14, 31, 43, 47, 60, 63, 74, 92, 96, 100, 131, 142, 144, 146, 148], "adopt": [0, 6, 8, 10, 11, 14, 15, 19, 23, 32, 39, 55, 78, 82, 86, 88, 100, 105, 111, 113, 148, 150], "obtain": [0, 3, 4, 6, 7, 10, 13, 16, 18, 20, 21, 22, 24, 25, 27, 29, 33, 34, 36, 38, 39, 41, 43, 45, 46, 49, 50, 51, 52, 55, 60, 65, 66, 69, 70, 72, 73, 74, 75, 76, 78, 80, 82, 83, 86, 88, 89, 91, 93, 94, 99, 100, 101, 104, 106, 111, 113, 115, 117, 118, 122, 123, 124, 125, 130, 133, 136, 139, 142, 143, 144, 145, 146, 148, 149, 150, 157], "get_str": [0, 26], "contract": [0, 10, 13, 14, 17, 20, 21, 26, 28, 33, 46, 47, 49, 52, 61, 70, 72, 75, 82, 100, 120, 125, 143, 148], "gto": [0, 20, 21, 26, 100, 120, 125, 143, 144, 145, 148], "primit": [0, 20, 21, 26, 84, 100, 120, 125, 143, 148], "2p": [0, 21, 24, 26, 52, 90, 101, 120, 122, 124, 125, 141, 143, 144, 148, 157], "10": [0, 1, 2, 3, 4, 6, 7, 8, 12, 13, 14, 18, 20, 21, 24, 27, 31, 33, 38, 39, 44, 47, 60, 62, 65, 67, 70, 72, 75, 76, 81, 82, 83, 84, 86, 89, 90, 91, 94, 96, 98, 99, 100, 101, 105, 106, 111, 113, 120, 122, 123, 124, 125, 130, 131, 132, 142, 143, 144, 148, 150, 153, 156, 157], "4p": [0, 21, 26, 100, 120, 125, 148], "13": [0, 14, 20, 21, 24, 34, 36, 39, 41, 62, 67, 70, 72, 75, 76, 90, 98, 100, 101, 113, 120, 122, 124, 125, 143, 148, 156], "30": [0, 8, 14, 20, 21, 22, 38, 47, 62, 70, 82, 83, 84, 89, 90, 91, 101, 120, 124, 125, 131, 143, 148, 150, 156], "up": [0, 3, 21, 22, 27, 33, 35, 38, 42, 43, 45, 46, 47, 52, 55, 67, 72, 73, 74, 75, 83, 91, 96, 98, 106, 113, 117, 131, 136, 137, 139, 144, 148], "restrict": [0, 7, 9, 11, 14, 15, 20, 21, 28, 29, 33, 49, 68, 70, 82, 90, 91, 92, 100, 101, 105, 106, 120, 121, 124, 125, 126, 142, 143, 144, 145], "driver": [0, 3, 4, 7, 13, 14, 20, 21, 33, 34, 36, 41, 44, 52, 58, 70, 71, 72, 75, 76, 83, 90, 98, 100, 101, 120, 124, 125, 131, 132, 136, 137, 139, 143, 144, 148], "scf_drv": [0, 2, 3, 4, 6, 7, 8, 10, 13, 14, 17, 18, 20, 21, 22, 25, 26, 28, 33, 34, 36, 38, 39, 41, 44, 47, 52, 58, 59, 65, 70, 75, 76, 78, 83, 86, 88, 89, 90, 92, 94, 96, 98, 101, 102, 105, 106, 113, 115, 120, 124, 130, 142, 144, 148, 151, 153, 157], "scfrestricteddriv": [0, 2, 3, 4, 6, 7, 8, 10, 13, 14, 17, 18, 20, 21, 22, 25, 26, 28, 33, 34, 36, 38, 39, 41, 47, 52, 65, 75, 76, 78, 83, 86, 88, 89, 90, 92, 94, 96, 98, 101, 102, 105, 106, 113, 115, 120, 122, 124, 130, 131, 132, 136, 137, 142, 143, 144, 145, 148, 151, 153, 157], "mute": [0, 2, 3, 4, 6, 7, 8, 10, 13, 14, 17, 18, 20, 21, 22, 24, 25, 26, 28, 33, 34, 36, 41, 44, 52, 58, 59, 76, 78, 83, 86, 88, 89, 94, 96, 98, 102, 105, 115, 130, 131, 132, 136, 139, 153, 157], "scf_result": [0, 2, 3, 4, 6, 7, 8, 10, 13, 14, 17, 18, 20, 21, 22, 25, 26, 28, 33, 34, 36, 38, 39, 41, 47, 52, 65, 70, 75, 76, 78, 83, 86, 88, 89, 90, 92, 94, 96, 98, 101, 102, 105, 106, 113, 115, 120, 124, 130, 136, 142, 144, 145, 148, 151, 153, 157], "want": [0, 3, 21, 33, 42, 43, 46, 47, 92, 100, 101, 120, 133, 144], "full": [0, 2, 3, 4, 20, 21, 32, 35, 42, 47, 62, 66, 69, 90, 93, 101, 108, 113, 118, 123, 124, 133, 139, 140, 142, 143, 144, 146, 150], "output": [0, 43, 47, 65, 90, 92, 113, 124, 125], "your": [0, 1, 33, 43, 52, 126], "remov": [0, 10, 12, 15, 20, 66, 89, 90, 144], "statement": 0, "itself": [0, 3, 4, 5, 18, 31, 49, 50, 61, 74, 76, 96, 98], "long": [0, 3, 5, 19, 20, 21, 25, 33, 38, 43, 53, 67, 88, 92, 120, 128, 139], "collaps": [0, 72, 90, 144, 148], "blue": [0, 70, 105, 157], "bar": [0, 11, 15, 26, 29, 61, 66, 70, 72, 75, 80, 88, 90, 94, 97, 100, 106, 111, 124, 144, 150], "left": [0, 7, 8, 11, 16, 19, 20, 22, 25, 26, 27, 28, 29, 31, 38, 45, 46, 47, 49, 52, 55, 60, 65, 70, 71, 72, 73, 75, 76, 78, 80, 82, 83, 84, 86, 88, 89, 90, 94, 97, 99, 100, 102, 106, 108, 111, 113, 117, 124, 130, 133, 141, 142, 143, 144, 148, 150, 151], "activ": [0, 3, 19, 20, 21, 24, 33, 42, 43, 61, 67, 74, 75, 82, 90, 92, 101, 105, 120, 122, 124, 132, 150, 152, 157], "enabl": [0, 19, 31, 42, 43, 69, 71, 89, 141], "store": [0, 3, 17, 21, 33, 71, 94, 100, 113, 132, 156], "analysi": [0, 43, 50, 54, 65, 67, 69, 78, 82, 90, 96, 99, 102, 105, 123, 124, 129, 141, 144, 145, 155, 156], "further": [0, 3, 18, 45, 47, 61, 63, 65, 70, 72, 73, 80, 82, 90, 91, 96, 99, 142, 143, 148, 153], "In": [0, 3, 4, 5, 6, 7, 9, 10, 11, 12, 13, 14, 16, 17, 18, 19, 20, 21, 23, 24, 25, 26, 27, 28, 31, 32, 33, 34, 37, 38, 39, 40, 41, 42, 43, 45, 46, 47, 48, 50, 51, 52, 53, 55, 57, 60, 61, 66, 67, 69, 70, 71, 72, 74, 75, 78, 80, 82, 83, 84, 86, 88, 90, 91, 93, 94, 96, 97, 99, 100, 101, 102, 106, 108, 113, 117, 120, 121, 122, 123, 124, 129, 131, 132, 133, 136, 141, 143, 144, 147, 148, 151, 154, 156, 157], "better": [0, 20, 21, 22, 39, 47, 55, 62, 89, 90, 91, 92, 101, 113, 122, 139, 143, 144, 149, 159], "what": [0, 3, 20, 21, 43, 47, 52, 60, 61, 82, 90, 92, 96, 122, 126, 128, 131, 133, 143, 144, 146, 147, 149, 153], "docstr": 0, "inform": [0, 11, 14, 20, 25, 47, 60, 65, 70, 74, 82, 91, 100, 120, 123, 124, 125, 141, 142, 143, 144, 145, 148], "get": [0, 3, 4, 6, 7, 10, 11, 15, 17, 18, 20, 21, 22, 24, 27, 28, 29, 33, 38, 39, 46, 47, 52, 65, 70, 72, 75, 76, 78, 82, 83, 86, 88, 89, 94, 96, 97, 98, 100, 113, 120, 122, 124, 131, 132, 133, 142, 143, 144, 149, 150, 156, 157], "help": [0, 72, 73, 90, 128, 130, 149], "scfrestdriv": [0, 131], "class": [0, 3, 4, 13, 16, 18, 19, 22, 28, 29, 34, 36, 41, 59, 60, 62, 64, 72, 75, 76, 86, 89, 94, 98, 106, 113, 115, 131, 144], "scfdriver": 0, "comm": [0, 72, 125, 144, 145], "implement": [0, 3, 5, 10, 12, 14, 16, 20, 23, 29, 32, 33, 36, 39, 43, 45, 46, 52, 59, 67, 68, 83, 88, 89, 97, 106, 124, 148, 153], "spin": [0, 3, 9, 11, 12, 13, 15, 19, 20, 22, 24, 26, 28, 29, 30, 33, 38, 67, 70, 72, 90, 100, 101, 120, 124, 125, 128, 141, 144, 148, 149, 150, 157], "close": [0, 4, 5, 6, 7, 8, 11, 14, 15, 19, 20, 21, 24, 25, 28, 29, 31, 38, 39, 47, 55, 59, 60, 67, 70, 74, 86, 88, 91, 97, 101, 102, 113, 121, 122, 123, 131, 132, 133, 141, 143, 144, 148, 149, 154, 156], "shell": [0, 7, 11, 14, 15, 18, 20, 24, 25, 28, 29, 31, 38, 67, 70, 86, 88, 91, 92, 97, 102, 113, 122, 148, 149], "c2": [0, 67, 81, 133], "dii": [0, 7, 14, 67], "two": [0, 3, 7, 8, 9, 10, 11, 14, 16, 18, 19, 20, 21, 22, 24, 26, 27, 31, 33, 35, 36, 39, 45, 46, 47, 49, 55, 59, 60, 61, 62, 68, 69, 70, 71, 72, 73, 74, 78, 80, 84, 86, 88, 91, 97, 98, 100, 102, 111, 113, 120, 122, 123, 124, 125, 130, 132, 133, 142, 143, 145, 146, 148, 153], "converg": [0, 3, 7, 20, 21, 25, 27, 33, 39, 41, 43, 55, 60, 65, 67, 70, 72, 75, 76, 83, 89, 90, 92, 98, 100, 101, 106, 120, 124, 125, 142, 143, 144, 145, 148, 153], "acceler": [0, 7, 20, 21, 55, 67, 70, 120, 125, 143, 148, 150], "param": [0, 60, 70], "mpi": [0, 43, 125, 145], "commun": [0, 5, 71], "stream": 0, "resolut": [0, 67, 124, 151], "builtin": 0, "__deepcopy__": 0, "self": [0, 12, 13, 15, 19, 20, 23, 29, 32, 41, 43, 46, 49, 67, 70, 90, 101, 108, 120, 124, 125, 141, 142, 144, 148, 149], "memo": 0, "deepcopi": [0, 143, 144, 145, 148], "__init__": [0, 29, 144], "initi": [0, 3, 7, 14, 20, 33, 39, 42, 52, 55, 58, 59, 60, 62, 64, 65, 69, 70, 72, 73, 74, 75, 90, 92, 100, 102, 108, 120, 124, 125, 126, 129, 133, 143, 144, 148, 153, 159], "default": [0, 3, 6, 7, 18, 20, 21, 36, 42, 46, 65, 113, 122, 137], "setup": [0, 8, 20, 27, 34, 36, 41, 70, 72, 76, 81, 82, 89, 98, 100, 120, 125, 143, 148], "threshold": [0, 3, 10, 20, 41, 60, 70, 72, 75, 76, 83, 89, 90, 98, 100, 101, 120, 124, 125, 142, 143, 148], "guess": [0, 3, 7, 14, 20, 21, 26, 33, 39, 64, 70, 72, 92, 100, 120, 125, 143, 144, 148], "etc": [0, 19, 30, 43, 99, 111, 142, 149], "base": [0, 3, 8, 14, 15, 21, 26, 33, 38, 41, 42, 43, 46, 47, 49, 50, 52, 55, 60, 62, 67, 68, 70, 73, 80, 83, 96, 99, 102, 105, 115, 122, 129, 130, 149, 153, 156], "constructor": 0, "get_scf_type_str": 0, "overload": 0, "inherit": [0, 117], "ao_basi": [0, 144], "min_basi": 0, "data": [0, 8, 43, 47, 51, 52, 58, 60, 62, 65, 70, 76, 91, 92, 100, 105, 131, 132, 133, 141, 153, 154, 156, 157], "minim": [0, 3, 4, 7, 12, 14, 15, 16, 19, 20, 21, 26, 34, 36, 38, 42, 47, 60, 64, 70, 71, 92, 101, 139, 143, 148, 149, 157], "compute_s2": [0, 122], "scf_tensor": [0, 70, 72, 81, 86], "expect": [0, 3, 4, 6, 10, 15, 20, 22, 29, 31, 39, 41, 46, 72, 80, 82, 84, 89, 90, 96, 99, 101, 106, 111, 120, 122, 128, 131, 143, 144, 149], "": [0, 3, 7, 10, 11, 13, 14, 15, 17, 19, 20, 21, 22, 24, 25, 26, 28, 29, 31, 33, 34, 36, 38, 39, 40, 41, 42, 43, 45, 46, 47, 49, 52, 53, 54, 55, 60, 61, 65, 66, 67, 70, 71, 72, 73, 74, 75, 76, 81, 82, 89, 90, 91, 92, 96, 98, 101, 105, 106, 111, 113, 117, 120, 122, 123, 124, 130, 132, 133, 143, 144, 146, 148, 150, 153, 156], "oper": [0, 3, 6, 7, 9, 10, 14, 15, 16, 17, 21, 22, 26, 27, 31, 38, 41, 46, 56, 63, 69, 72, 73, 75, 76, 78, 82, 84, 89, 90, 91, 94, 97, 98, 99, 100, 102, 106, 111, 113, 117, 122, 123, 143, 148], "tensor": [0, 8, 13, 38, 40, 61, 66, 71, 74, 76, 83, 84, 88, 89, 98, 117, 132, 143, 150], "wavefunct": [0, 3, 20, 21, 23, 33, 75, 90, 91, 93, 101, 120, 122, 124], "get_scf_energi": [0, 2, 3, 4, 7, 8, 13, 14, 20, 21, 24, 25, 33, 47, 52, 72, 120, 122, 136, 137, 143, 144], "previou": [0, 3, 14, 19, 21, 33, 39, 42, 46, 55, 60, 66, 72, 75, 82, 91, 97, 101, 137, 139, 143, 144, 156], "iter": [0, 3, 6, 7, 15, 20, 21, 33, 39, 41, 43, 46, 47, 59, 60, 65, 67, 70, 72, 75, 76, 89, 90, 98, 100, 101, 105, 113, 120, 124, 125, 143, 144, 148, 156], "maximum_overlap": [0, 122, 143, 144], "alpha_list": 0, "beta_list": 0, "constraint": [0, 3, 14, 15, 19, 36, 41, 46, 47, 58, 143, 144, 145, 148], "find": [0, 1, 4, 15, 20, 21, 28, 30, 31, 36, 42, 43, 44, 46, 48, 55, 57, 60, 66, 72, 76, 84, 91, 92, 94, 97, 113, 122], "maxim": [0, 64, 139, 144], "overlap": [0, 7, 13, 14, 15, 20, 21, 24, 38, 39, 46, 49, 67, 70, 72, 96, 106, 111, 120, 122, 125, 143, 147, 148, 150], "refer": [0, 1, 3, 6, 8, 11, 15, 16, 18, 19, 21, 24, 25, 26, 28, 29, 30, 31, 33, 34, 36, 41, 42, 43, 45, 46, 47, 49, 50, 54, 66, 73, 76, 82, 83, 86, 88, 89, 90, 91, 96, 98, 103, 104, 108, 111, 113, 120, 124, 128, 144, 145, 146, 149, 150, 152], "molecularorbit": [0, 21], "alpha": [0, 3, 4, 6, 7, 8, 13, 15, 17, 18, 19, 20, 24, 26, 28, 31, 33, 36, 38, 41, 47, 49, 60, 61, 70, 71, 75, 76, 78, 82, 83, 84, 86, 88, 89, 91, 96, 97, 98, 99, 105, 111, 113, 117, 120, 122, 132, 142, 143, 144, 150, 153, 157], "occupi": [0, 3, 4, 7, 10, 11, 14, 15, 17, 18, 20, 21, 22, 24, 25, 26, 28, 29, 30, 31, 33, 46, 49, 70, 72, 75, 80, 86, 88, 90, 94, 96, 97, 101, 111, 113, 115, 120, 122, 124, 125, 141, 142, 143, 144, 149, 150, 157], "beta": [0, 3, 6, 7, 13, 15, 17, 18, 19, 20, 24, 26, 28, 31, 33, 36, 38, 41, 47, 70, 71, 74, 75, 76, 78, 82, 83, 84, 88, 89, 91, 96, 97, 98, 111, 113, 117, 120, 122, 143, 144, 150, 153, 157], "print_attribut": 0, "attribut": [0, 1], "print_keyword": [0, 100], "input": [0, 17, 43, 47, 100, 133], "keyword": [0, 3], "set_start_orbit": 0, "arrai": [0, 3, 4, 7, 8, 10, 13, 18, 20, 21, 24, 27, 33, 38, 39, 43, 44, 47, 52, 60, 62, 70, 75, 81, 83, 86, 88, 92, 97, 99, 101, 106, 113, 120, 131, 132, 142, 143, 148, 156, 157], "checkpoint": [0, 132, 143, 156], "file": [0, 20, 21, 26, 39, 43, 47, 62, 65, 67, 70, 92, 94, 100, 105, 120, 125, 131, 132, 133, 143, 148, 153, 154, 156, 159], "tupl": [0, 13], "update_set": [0, 33, 41, 81, 100, 106, 113, 122, 124, 131, 132, 142, 144, 148, 151, 153], "scf_dict": [0, 33, 153], "method_dict": [0, 153], "updat": [0, 3, 21, 22, 33, 42, 60, 131, 132, 143, 144], "dicitonari": 0, "write_checkpoint": 0, "nuclear_charg": 0, "basis_set": [0, 4, 18, 78, 136, 143], "nuclear": [0, 3, 7, 11, 14, 15, 16, 20, 25, 28, 33, 38, 39, 45, 46, 47, 48, 49, 50, 55, 60, 61, 66, 67, 70, 83, 89, 100, 103, 120, 125, 130, 141, 143, 148, 150], "charg": [0, 4, 8, 11, 19, 20, 25, 26, 31, 35, 37, 39, 40, 47, 61, 62, 67, 70, 80, 81, 82, 84, 91, 104, 120, 125, 128, 141, 143, 144, 148, 150, 153], "name": [0, 3, 4, 13, 14, 16, 18, 19, 20, 22, 25, 29, 42, 46, 59, 62, 70, 72, 73, 76, 81, 82, 88, 94, 98, 101, 113, 122, 150, 154], "readonli": 0, "properti": [0, 3, 5, 11, 12, 16, 19, 21, 29, 33, 39, 40, 43, 45, 47, 48, 66, 67, 68, 74, 76, 78, 89, 93, 97, 98, 99, 101, 103, 106, 109, 111, 117, 118, 124, 129, 141, 143, 144, 148, 149, 150, 153], "densiti": [0, 2, 6, 7, 8, 9, 12, 13, 14, 15, 16, 17, 21, 23, 24, 26, 31, 36, 39, 40, 43, 46, 61, 67, 69, 72, 73, 75, 76, 80, 89, 94, 96, 98, 101, 104, 105, 108, 111, 120, 122, 125, 126, 137, 142, 143, 145, 148, 150, 152, 158], "matrix": [0, 3, 4, 6, 9, 12, 14, 15, 18, 20, 21, 24, 27, 28, 29, 30, 36, 38, 39, 41, 43, 45, 46, 49, 50, 52, 60, 61, 66, 67, 69, 71, 73, 75, 76, 80, 82, 86, 88, 94, 96, 97, 98, 106, 115, 117, 120, 125, 130, 132, 143, 144, 148, 150, 153], "is_converg": [0, 21, 33], "whether": [0, 46, 50, 144], "mol_orb": [0, 2, 3, 4, 8, 13, 17, 20, 21, 22, 24, 25, 33, 70, 75, 86, 90, 92, 101, 102, 113, 120, 122, 124, 125, 137, 142, 143, 144, 157], "backward": [0, 21, 65], "compat": 0, "molecular_orbit": [0, 20, 21, 24, 120, 122], "nnode": 0, "node": [0, 17, 43, 70, 71, 72, 76, 89, 98, 148, 157], "num_it": 0, "current": [0, 5, 21, 42, 43, 55, 60, 89, 104, 124, 125, 143, 144, 147, 150], "rank": [0, 84, 91, 113, 117], "scf_energi": [0, 13, 39, 52, 83], "scf_type": [0, 13], "descriptor": [0, 142], "__dict__": 0, "__weakref__": 0, "weak": [0, 43, 47, 55, 76, 82, 92, 106, 111, 143, 144, 149, 150], "filenam": [0, 94, 105, 120, 153], "getter": 0, "protect": 0, "final": [0, 3, 7, 11, 13, 14, 20, 21, 31, 33, 43, 46, 49, 51, 55, 59, 62, 65, 66, 69, 70, 75, 82, 88, 90, 92, 97, 100, 101, 102, 120, 123, 124, 125, 126, 129, 139, 140, 142, 143, 144, 148, 149, 153], "see": [0, 3, 8, 20, 21, 22, 33, 39, 42, 43, 46, 47, 51, 52, 55, 59, 60, 63, 65, 69, 70, 72, 73, 75, 78, 82, 90, 91, 101, 105, 106, 113, 120, 122, 124, 125, 129, 133, 137, 139, 141, 142, 143, 144, 148, 150, 153, 154, 156, 159], "access": [0, 4, 6, 8, 18, 36, 43, 65, 72, 113], "auto": [0, 113], "complet": [0, 3, 4, 11, 20, 21, 29, 38, 46, 55, 67, 72, 78, 96, 136, 149, 153], "tab": 0, "option": [0, 58, 60, 65, 133], "same": [0, 3, 4, 6, 18, 19, 20, 21, 22, 25, 28, 29, 31, 33, 42, 43, 46, 47, 49, 50, 55, 60, 69, 70, 72, 73, 75, 76, 82, 98, 106, 113, 120, 122, 123, 129, 132, 133, 142, 143, 144, 148, 150, 153], "75": [0, 7, 8, 14, 18, 20, 28, 33, 39, 47, 52, 60, 70, 75, 76, 89, 90, 100, 101, 120, 124, 130, 131, 132, 143, 148, 156, 157], "98387037576917": 0, "light": [0, 8, 11, 38, 61, 66, 67, 74, 75, 82, 89, 91, 92, 98, 103, 111, 113, 117, 120, 123, 129, 130, 132, 144, 150, 157], "weight": [0, 3, 6, 7, 14, 18, 21, 22, 24, 46, 47, 49, 52, 90, 101, 122, 124, 149, 153, 157], "interact": [0, 2, 4, 9, 15, 19, 21, 22, 31, 32, 35, 39, 40, 43, 46, 62, 67, 69, 72, 73, 74, 82, 91, 111, 115, 118, 120, 124, 133, 141, 142, 144, 149, 153, 154, 156, 157], "orbitalview": [0, 13, 21, 70, 92, 94, 102, 113, 120, 125, 137, 152, 153], "viewer": [0, 13, 21, 33, 39, 47, 59, 62, 65, 70, 90, 92, 94, 102, 113, 120, 124, 125, 131, 132, 133, 136, 137, 139, 153, 154, 156, 157, 159], "provid": [0, 3, 4, 5, 12, 16, 18, 19, 21, 26, 33, 39, 43, 46, 47, 52, 62, 68, 69, 70, 74, 86, 89, 94, 99, 101, 102, 111, 113, 121, 124, 125, 128, 133, 139, 141, 142, 143, 144, 145, 146, 148, 149, 150, 153, 157], "seven": [0, 24, 122], "drop": [0, 3, 90, 149], "menu": [0, 13, 102], "lower": [0, 3, 18, 20, 22, 31, 38, 41, 47, 58, 60, 72, 83, 89, 94, 101, 102, 106, 113, 122, 124, 129, 130, 133, 142, 143, 144, 148], "sto": [0, 3, 4, 21, 26, 33, 47, 52, 65, 70, 130, 139, 157], "3g": [0, 3, 4, 11, 21, 26, 33, 47, 52, 65, 70, 130, 139, 157], "yield": [0, 16, 46, 47, 49, 66, 70, 72, 76, 82, 91, 109, 111, 128, 141, 142, 143, 144, 148, 149], "per": [0, 26, 36, 41, 47, 72, 94, 100, 136, 143, 148, 150], "hydrogen": [0, 4, 20, 31, 33, 36, 38, 39, 41, 47, 120, 124, 131, 132, 133, 139, 144, 149, 150], "five": [0, 11, 17, 18, 29, 38, 46, 66, 83, 115, 136], "oxygen": [0, 3, 10, 18, 21, 24, 39, 67, 90, 92, 101, 122, 124, 139, 143, 144, 145, 159], "three": [0, 16, 19, 26, 31, 33, 39, 46, 47, 52, 55, 66, 67, 76, 80, 82, 91, 99, 100, 111, 117, 123, 130, 132, 133, 142, 150], "upper": [0, 31, 38, 53, 102, 113, 124, 142, 157], "isosurfac": 0, "under": [0, 1, 7, 11, 14, 15, 16, 19, 20, 30, 42, 76, 82, 91, 98, 103, 130, 153], "neg": [0, 3, 20, 33, 39, 46, 49, 64, 65, 70, 88, 91, 100, 122, 144, 148, 153, 157], "treat": [0, 21, 75, 82, 88, 120], "individu": [0, 3, 17, 28, 29, 46, 47, 55, 66, 71, 78, 80, 89, 91, 154, 156], "abl": [0, 3, 13, 20, 21, 46, 52, 69, 82, 111, 153, 157], "compil": [0, 62, 153, 157], "It": [0, 3, 4, 5, 6, 7, 8, 10, 11, 12, 14, 15, 18, 20, 21, 22, 26, 31, 38, 42, 43, 45, 46, 47, 49, 60, 64, 70, 71, 72, 74, 82, 83, 86, 89, 90, 92, 97, 99, 100, 105, 108, 111, 113, 117, 120, 122, 143, 144, 148, 149, 153, 157], "work": [0, 3, 4, 18, 25, 26, 42, 43, 45, 46, 52, 54, 55, 82, 91, 104, 108, 123, 128, 133, 142, 143, 144, 147, 148, 149, 153, 154, 156, 157], "though": [0, 20, 21, 98, 144, 153, 157], "let": [0, 3, 4, 6, 7, 8, 10, 14, 16, 17, 18, 20, 21, 22, 24, 25, 27, 29, 30, 31, 33, 34, 36, 38, 39, 41, 43, 46, 52, 58, 60, 70, 71, 74, 75, 76, 78, 82, 83, 86, 89, 90, 92, 94, 96, 97, 98, 101, 102, 105, 120, 122, 124, 130, 132, 143, 156], "u": [0, 1, 2, 3, 4, 6, 7, 8, 10, 11, 13, 14, 15, 16, 17, 18, 20, 21, 22, 24, 27, 28, 29, 30, 31, 33, 34, 36, 38, 39, 41, 43, 45, 46, 49, 52, 58, 60, 62, 67, 70, 72, 74, 75, 76, 78, 82, 83, 86, 88, 89, 90, 91, 94, 96, 97, 98, 99, 100, 101, 102, 105, 111, 113, 120, 122, 124, 125, 131, 132, 141, 143, 144, 148, 150, 153, 154, 157], "impact": [0, 115, 136, 141, 144, 147], "total": [0, 3, 7, 12, 18, 20, 21, 22, 24, 25, 28, 29, 31, 33, 34, 36, 38, 39, 41, 45, 46, 49, 55, 70, 72, 73, 80, 83, 84, 90, 91, 100, 101, 120, 122, 124, 125, 136, 137, 139, 142, 143, 144, 148], "gener": [0, 1, 6, 7, 14, 15, 16, 18, 20, 21, 23, 26, 28, 29, 30, 31, 40, 43, 45, 46, 47, 48, 49, 52, 60, 62, 66, 67, 68, 72, 73, 74, 75, 76, 82, 84, 88, 89, 91, 93, 98, 99, 101, 111, 113, 117, 120, 122, 123, 124, 128, 129, 133, 136, 141, 143, 144, 148, 149, 150, 154, 159], "trend": [0, 20, 144, 149], "increas": [0, 3, 4, 17, 20, 22, 27, 39, 47, 53, 71, 78, 89, 91, 101, 120, 124, 128, 133, 142, 143, 144], "size": [0, 18, 21, 26, 31, 43, 55, 60, 67, 68, 69, 70, 71, 75, 76, 82, 89, 98, 115, 142, 143, 144, 148, 153, 157], "calc_scf": 0, "n_ba": [0, 143], "get_dimensions_of_basi": [0, 4, 7, 10, 13, 14, 18, 21, 24, 26, 28, 38, 106], "empti": [0, 3, 21, 33, 52, 75, 122, 142], "basis_s": 0, "element": [0, 3, 4, 9, 11, 14, 15, 21, 24, 26, 28, 29, 30, 33, 38, 39, 41, 45, 46, 47, 52, 61, 66, 67, 69, 70, 71, 72, 73, 75, 76, 80, 82, 84, 86, 88, 91, 94, 97, 98, 105, 113, 117, 130, 131, 132, 139, 141, 143, 144, 149, 150, 156], "modifi": [0, 3, 7, 18, 25, 33, 43, 46], "place": [0, 8, 11, 20, 25, 33, 38, 69, 70, 73, 82, 123], "within": [0, 3, 12, 16, 19, 20, 21, 27, 43, 46, 47, 55, 67, 72, 75, 80, 82, 88, 90, 91, 101, 113, 133, 143, 144, 148], "bracket": [0, 82], "list_exampl": 0, "cat": 0, "dog": 0, "Or": [0, 106, 131, 132], "loop": [0, 3, 33, 47, 59, 60, 62, 65, 70, 92, 130, 131, 132, 154, 156], "718281828459045": 0, "311g": [0, 26, 136, 137, 143, 144, 149], "31": [0, 3, 14, 20, 24, 26, 62, 67, 89, 90, 97, 100, 101, 120, 124, 131, 143, 150, 156], "311": [0, 26, 143, 146, 149], "design": [0, 33, 41, 43, 52, 67, 74, 82, 89, 94, 103, 124, 150], "mean": [0, 3, 7, 9, 10, 15, 16, 20, 21, 22, 27, 28, 29, 30, 34, 36, 38, 41, 43, 46, 47, 49, 53, 55, 58, 61, 64, 69, 72, 75, 82, 83, 94, 96, 97, 101, 102, 106, 113, 122, 124, 130, 141, 143, 144, 149, 150, 153], "elsewher": [0, 28, 84, 149], "energy_tmp": 0, "n_bas_tmp": 0, "append": [0, 3, 4, 7, 8, 14, 18, 20, 21, 22, 27, 33, 38, 39, 44, 47, 52, 60, 62, 70, 75, 81, 86, 92, 96, 101, 106, 113, 120, 124, 131, 142, 143, 144, 148, 156], "hang": 0, "too": [0, 3, 20, 47, 55, 75, 82, 89, 101, 113, 120, 128, 143, 144, 147, 149], "kernel": [0, 5, 6, 42, 46, 49, 143, 144, 145, 148], "appeal": [0, 83], "figsiz": [0, 2, 3, 4, 7, 8, 14, 18, 20, 21, 28, 31, 33, 47, 52, 58, 59, 60, 62, 70, 75, 81, 92, 96, 99, 100, 101, 106, 113, 120, 124, 125, 130, 131, 132, 142, 143, 144, 145, 148, 151, 156, 157], "titl": [0, 3, 20, 21, 31, 33, 43, 52, 62, 70, 75, 92, 101, 105, 113, 120, 124, 130, 131, 132, 142, 143, 144, 151, 153, 156, 157], "nicer": [0, 159], "circl": [0, 4, 74, 82], "point": [0, 4, 6, 7, 8, 12, 19, 20, 21, 22, 27, 33, 34, 35, 36, 38, 39, 41, 45, 46, 47, 48, 49, 50, 51, 52, 56, 60, 64, 65, 66, 70, 73, 76, 82, 83, 84, 88, 89, 91, 96, 98, 99, 100, 102, 103, 122, 123, 143, 144, 148, 149, 157], "connect": [0, 19, 42, 43, 47, 72, 74, 82, 91, 103, 117, 133, 139], "dash": [0, 4, 113, 120, 143, 157], "d": [0, 3, 6, 7, 8, 11, 13, 14, 15, 16, 17, 18, 19, 21, 22, 24, 25, 28, 29, 30, 34, 36, 38, 39, 40, 41, 45, 46, 49, 60, 61, 66, 67, 69, 70, 71, 72, 73, 82, 83, 84, 86, 91, 94, 100, 105, 129, 130, 131, 132, 143, 150, 151, 153, 156], "color": [0, 4, 8, 14, 18, 20, 31, 39, 47, 52, 58, 60, 70, 99, 101, 105, 113, 120, 124, 125, 143, 157, 159], "red": [0, 18, 38, 60, 70, 101, 105, 157, 159], "label": [0, 3, 4, 7, 8, 14, 16, 18, 19, 20, 21, 26, 27, 28, 33, 34, 36, 41, 46, 49, 52, 58, 60, 61, 66, 70, 72, 75, 81, 91, 92, 96, 100, 101, 105, 120, 131, 132, 133, 141, 143, 148, 151, 156], "legend": [0, 3, 4, 7, 8, 14, 18, 20, 21, 27, 28, 33, 47, 52, 58, 60, 62, 70, 75, 81, 92, 96, 100, 101, 105, 106, 113, 120, 124, 131, 132, 142, 143, 144, 148, 156, 157], "xlim": [0, 4, 18, 27, 28, 31, 47, 70, 99, 124, 142, 143, 144, 157], "37": [0, 20, 24, 62, 67, 90, 98, 101, 120, 122, 125, 143, 144, 148, 156], "limit": [0, 6, 11, 14, 20, 21, 30, 38, 46, 53, 55, 67, 76, 78, 82, 83, 86, 89, 91, 98, 113, 136, 144, 149, 154], "x": [0, 1, 3, 4, 7, 8, 10, 11, 17, 18, 19, 20, 21, 24, 31, 33, 39, 43, 45, 46, 47, 49, 52, 60, 61, 66, 67, 69, 70, 71, 72, 73, 75, 81, 82, 88, 89, 90, 91, 92, 94, 96, 100, 101, 102, 104, 106, 111, 113, 115, 120, 122, 124, 125, 128, 129, 130, 131, 132, 134, 142, 143, 145, 146, 149, 150, 151, 153, 156, 157], "axi": [0, 4, 6, 8, 11, 20, 28, 31, 38, 52, 60, 66, 82, 83, 84, 88, 96, 98, 105, 113, 120, 124, 131, 143, 156, 157], "ylim": [0, 4, 8, 18, 28, 31, 47, 70, 92, 99, 105, 124, 143, 144, 157], "76": [0, 7, 8, 13, 14, 20, 39, 67, 75, 76, 90, 101, 120, 124, 125, 143, 148, 156], "74": [0, 7, 14, 20, 21, 24, 52, 70, 120, 143, 156], "8": [0, 3, 7, 8, 14, 18, 20, 21, 24, 27, 28, 31, 33, 34, 36, 38, 39, 44, 46, 58, 60, 62, 65, 67, 70, 72, 75, 76, 81, 82, 83, 84, 86, 88, 89, 90, 91, 97, 98, 100, 101, 102, 105, 113, 115, 120, 122, 123, 124, 125, 131, 133, 136, 142, 143, 144, 145, 148, 150, 151, 153, 156, 157], "y": [0, 1, 8, 11, 14, 17, 18, 20, 21, 24, 31, 33, 38, 45, 46, 47, 49, 60, 61, 67, 70, 72, 75, 81, 82, 88, 89, 90, 91, 92, 100, 101, 106, 111, 113, 120, 124, 125, 130, 131, 132, 142, 143, 144, 148, 150, 151, 156, 157, 159], "grid": [0, 2, 6, 7, 8, 28, 34, 36, 41, 46, 58, 60, 62, 76, 89, 96, 98, 99, 100, 148], "xlabel": [0, 4, 7, 8, 14, 18, 20, 27, 28, 31, 33, 47, 52, 62, 70, 96, 99, 100, 101, 105, 113, 120, 130, 131, 132, 143, 144, 156, 157], "ylabel": [0, 2, 3, 4, 7, 8, 14, 18, 20, 27, 28, 31, 33, 47, 52, 62, 70, 75, 96, 99, 100, 101, 105, 113, 120, 130, 131, 132, 143, 144, 156, 157], "hartre": [0, 3, 4, 5, 6, 7, 8, 13, 14, 19, 20, 21, 24, 25, 27, 28, 32, 34, 36, 38, 39, 41, 43, 46, 49, 50, 70, 72, 80, 88, 89, 92, 96, 97, 100, 104, 105, 108, 111, 113, 120, 121, 122, 125, 136, 137, 143, 150], "clear": [0, 3, 18, 21, 25, 47, 55, 99, 101, 105, 111, 120, 142, 144, 150], "decreas": [0, 4, 55, 60, 80, 98, 143], "larger": [0, 3, 18, 20, 21, 25, 27, 33, 35, 39, 47, 52, 55, 89, 96, 97, 122, 123, 124, 129, 133, 139, 142, 143, 144, 148, 149, 153], "flexibl": [0, 4, 21, 43, 47, 122, 143, 149], "alwai": [0, 3, 20, 21, 47, 60, 89, 133, 143, 149, 150], "case": [0, 3, 7, 8, 14, 15, 18, 20, 21, 22, 24, 25, 26, 27, 28, 31, 33, 38, 43, 45, 46, 47, 49, 50, 55, 60, 61, 67, 69, 70, 74, 75, 76, 78, 82, 84, 86, 88, 89, 91, 94, 96, 98, 99, 100, 101, 103, 111, 113, 117, 120, 122, 123, 124, 128, 132, 133, 139, 143, 144, 149, 154], "smaller": [0, 3, 4, 20, 25, 27, 33, 72, 82, 89, 123, 129, 143, 144, 148], "suitabl": [0, 17, 55, 65, 89, 99, 133, 145, 149], "particular": [0, 3, 7, 14, 19, 20, 21, 31, 43, 46, 47, 60, 62, 72, 74, 75, 82, 86, 89, 90, 91, 101, 131, 141, 143, 148], "concept": [0, 3, 4, 19, 21, 32, 39, 43, 45, 65, 91, 94, 101], "chemistri": [0, 1, 3, 4, 5, 9, 12, 26, 35, 43, 45, 67, 99, 120, 141, 149], "paramet": [0, 3, 19, 21, 22, 26, 35, 39, 43, 46, 47, 55, 62, 76, 88, 90, 97, 98, 111, 113, 124, 144, 150, 154], "typic": [0, 3, 19, 21, 35, 42, 47, 60, 82, 83, 88, 90, 91, 101, 113, 115, 120, 123, 128, 133, 141, 142, 143, 144, 148, 149, 150, 155], "wish": [0, 1, 43, 97, 157], "carbon": [0, 26, 28, 34, 41, 67, 120, 136, 141, 142, 143, 144, 150], "monoxid": [0, 26, 28], "track": [0, 3], "bond": [0, 3, 4, 5, 19, 20, 21, 26, 33, 38, 39, 41, 45, 52, 53, 59, 65, 88, 92, 96, 100, 101, 130, 139, 144], "length": [0, 33, 45, 47, 52, 55, 60, 66, 75, 78, 90, 100, 101, 117, 120, 124, 139, 144, 148, 150], "distanc": [0, 3, 4, 8, 18, 20, 21, 33, 38, 47, 52, 58, 100, 102, 105, 124, 139, 153, 157], "arang": [0, 27, 47, 52, 60, 70, 81, 99, 100, 105, 106, 113, 124, 125, 130, 131, 132, 142, 143, 144, 148, 151, 156], "linspac": [0, 4, 8, 20, 28, 31, 58, 83, 96, 113, 120, 143, 157], "evenli": 0, "space": [0, 2, 3, 4, 11, 20, 21, 22, 25, 26, 31, 33, 34, 38, 46, 49, 60, 67, 69, 70, 71, 72, 75, 76, 82, 84, 89, 90, 91, 92, 96, 97, 98, 101, 113, 120, 122, 124, 126, 128, 142, 143, 144, 146, 147, 150, 152, 157], "interv": [0, 47, 100, 143], "either": [0, 1, 15, 33, 38, 42, 43, 46, 47, 48, 55, 60, 61, 66, 84, 124, 128, 131, 133, 134, 143, 149, 153, 154], "step": [0, 3, 11, 17, 21, 27, 38, 40, 46, 47, 52, 55, 56, 60, 64, 66, 75, 81, 88, 99, 108, 125, 130, 131, 132, 143, 145, 148, 154, 156], "give": [0, 4, 11, 16, 18, 20, 21, 26, 27, 38, 46, 47, 49, 55, 65, 66, 70, 72, 74, 75, 88, 90, 98, 102, 103, 105, 115, 123, 139, 142, 144], "end": [0, 3, 6, 8, 11, 14, 15, 16, 17, 19, 20, 22, 24, 25, 26, 27, 28, 29, 30, 31, 33, 36, 38, 39, 43, 45, 46, 47, 49, 55, 60, 71, 76, 81, 82, 83, 84, 86, 88, 89, 91, 94, 97, 98, 99, 102, 106, 111, 113, 117, 122, 125, 143, 144], "stop": 0, "num": 0, "7": [0, 1, 3, 4, 7, 8, 14, 18, 20, 21, 24, 25, 27, 28, 33, 38, 44, 52, 60, 61, 62, 65, 67, 70, 72, 75, 76, 81, 89, 90, 91, 98, 100, 101, 102, 105, 113, 120, 122, 123, 124, 125, 130, 131, 136, 142, 143, 144, 148, 150, 153, 156, 157], "9": [0, 3, 7, 8, 14, 18, 20, 21, 24, 26, 27, 31, 33, 38, 41, 44, 60, 62, 65, 67, 70, 72, 75, 76, 81, 83, 89, 90, 100, 101, 105, 113, 115, 120, 122, 123, 124, 125, 131, 136, 143, 144, 148, 150, 156], "ensur": [0, 16, 19, 29, 38, 42, 46, 60, 86, 98, 101, 133], "replac": [0, 3, 7, 8, 14, 20, 21, 33, 46, 47, 49, 52, 55, 101, 105, 120, 133, 139, 143, 153], "start_str": 0, "john": [0, 67], "went": 0, "bowl": 0, "jane": 0, "end_str": 0, "andrew": 0, "cinema": 0, "sarah": 0, "co_bas": [0, 47], "c": [0, 3, 7, 8, 10, 11, 13, 14, 15, 17, 18, 21, 22, 24, 25, 26, 28, 33, 34, 36, 38, 39, 40, 41, 43, 46, 47, 49, 58, 59, 61, 65, 66, 67, 69, 70, 72, 73, 75, 76, 81, 82, 84, 86, 88, 89, 91, 92, 94, 96, 98, 102, 105, 106, 113, 115, 120, 125, 129, 131, 132, 133, 136, 137, 139, 142, 143, 144, 146, 148, 150, 153, 156, 157, 159], "l": [0, 2, 3, 4, 14, 15, 17, 19, 20, 26, 27, 36, 38, 46, 47, 61, 66, 67, 71, 72, 76, 82, 89, 91, 94, 98, 100, 120, 141, 143, 148, 149], "bond_": [0, 47], "bond_l": [0, 47], "40": [0, 3, 4, 8, 20, 21, 24, 47, 60, 62, 65, 70, 75, 76, 83, 84, 86, 88, 90, 91, 98, 99, 100, 101, 120, 122, 124, 125, 143, 148, 150, 156], "04": [0, 7, 14, 18, 20, 21, 47, 65, 72, 75, 76, 81, 89, 90, 98, 100, 101, 113, 120, 124, 125, 139, 143, 148, 156], "co_tmp": [0, 47], "smoother": [0, 144], "aesthet": 0, "pleas": [0, 1, 60, 150], "piec": [0, 33, 52, 53], "wise": [0, 139], "polynomi": 0, "desir": [0, 21, 33, 38, 55, 72, 73, 124, 144, 148, 149], "cubic": [0, 8, 34, 47, 58, 83, 89, 113, 117, 124, 142, 144], "tend": [0, 20, 74, 128, 142, 144, 149], "rel": [0, 3, 19, 31, 34, 36, 41, 47, 53, 70, 91, 100, 101, 122, 124, 125, 128, 129, 139, 141, 142, 144, 146, 148, 149, 150], "smooth": [0, 20, 21, 27], "curv": [0, 8, 20, 21, 47, 58, 62, 92, 100], "spline_func": [0, 58], "interp1d": [0, 8, 47, 58, 113, 124, 142, 144], "kind": [0, 8, 11, 47, 58, 113, 124, 142, 144], "x_spline": [0, 58], "min": [0, 27, 44, 47, 58, 59, 60, 70, 72, 75, 76, 81, 89, 90, 98, 100, 113, 124, 142, 143, 144, 148, 154, 156], "max": [0, 3, 20, 33, 38, 41, 60, 70, 72, 75, 76, 81, 86, 89, 90, 98, 99, 100, 101, 113, 120, 124, 125, 139, 142, 143, 144, 148, 151, 154, 156], "100": [0, 1, 3, 4, 7, 20, 22, 28, 33, 60, 62, 67, 72, 81, 82, 113, 120, 143, 149, 150, 154, 156, 157], "y_spline": [0, 58], "stretch": [0, 21, 52, 53, 100, 120, 130, 131, 132], "approxim": [0, 3, 4, 5, 7, 14, 15, 16, 20, 21, 22, 26, 27, 31, 41, 46, 47, 53, 55, 60, 67, 69, 80, 84, 86, 88, 90, 91, 94, 98, 99, 100, 101, 104, 111, 113, 117, 128, 132, 136, 141, 143, 144, 149], "e_k": 0, "frac": [0, 3, 7, 8, 10, 15, 16, 19, 21, 22, 25, 28, 29, 30, 31, 33, 36, 38, 39, 41, 45, 46, 47, 49, 52, 55, 60, 61, 65, 66, 70, 72, 73, 74, 75, 76, 78, 80, 82, 83, 84, 86, 88, 89, 91, 96, 97, 98, 99, 100, 108, 111, 117, 122, 130, 150, 151], "k_": [0, 7, 8, 47, 150], "l_0": [0, 47], "Such": [0, 15, 16, 27, 73, 82, 102, 111, 143], "form": [0, 3, 5, 6, 7, 9, 10, 11, 14, 17, 19, 21, 25, 26, 28, 29, 30, 31, 35, 38, 46, 47, 49, 55, 67, 70, 73, 74, 76, 78, 80, 82, 83, 84, 89, 91, 96, 97, 99, 100, 102, 105, 111, 113, 120, 122, 124, 144, 148, 150], "forc": [0, 25, 35, 50, 53, 54, 55, 67, 91, 139, 150, 156], "field": [0, 3, 12, 13, 15, 20, 23, 31, 32, 33, 35, 38, 43, 46, 49, 53, 54, 55, 61, 67, 70, 74, 75, 76, 78, 84, 86, 89, 90, 98, 100, 101, 102, 103, 108, 111, 120, 122, 124, 125, 139, 143, 148, 150], "dynam": [0, 5, 20, 21, 23, 43, 47, 51, 52, 54, 55, 61, 67, 70, 74, 75, 76, 91, 98, 101, 125, 143, 144, 148, 154, 159], "optim": [0, 3, 5, 6, 8, 10, 18, 19, 20, 21, 25, 38, 39, 43, 45, 46, 47, 48, 53, 56, 58, 59, 62, 64, 67, 83, 89, 96, 102, 115, 122, 124, 126, 132, 140, 143, 144, 145, 148, 153, 155, 157], "curve_fit": [0, 47], "minima": [0, 8, 45, 47, 57, 60], "bond_e_shift": 0, "harmonic_func": 0, "popt": 0, "pcov": 0, "shape": [0, 3, 10, 17, 22, 33, 47, 52, 60, 70, 81, 86, 113, 151, 156], "wrong": [0, 21], "locat": [0, 18, 21, 39, 42, 45, 47, 67, 124, 133], "incorrect": [0, 6], "factor": [0, 3, 7, 14, 15, 29, 30, 31, 33, 36, 38, 55, 66, 82, 84, 88, 91, 94, 97, 124, 125, 141, 144, 145, 150, 151, 157], "inadequaci": 0, "somewhat": [0, 18, 21, 46, 72, 97, 108, 133], "unsuit": [0, 141, 149], "region": [0, 8, 18, 19, 20, 28, 35, 36, 39, 40, 43, 47, 60, 69, 74, 92, 96, 99, 100, 113, 122, 123, 124, 131, 142, 143, 144, 149], "discuss": [0, 3, 5, 11, 12, 21, 22, 30, 42, 43, 45, 48, 49, 51, 54, 57, 60, 61, 64, 69, 70, 72, 73, 82, 84, 91, 94, 103, 104, 108, 117, 123, 125, 126, 129, 130, 132, 136, 140, 141, 143, 146, 147, 148, 149, 151, 153, 155, 158], "our": [0, 3, 7, 10, 18, 20, 21, 26, 29, 33, 36, 38, 39, 52, 60, 62, 70, 82, 86, 88, 90, 91, 92, 96, 101, 113, 115, 120, 122, 137, 144, 149, 154], "softwar": [0, 26, 42, 54], "einsum": [0, 3, 6, 7, 10, 14, 17, 18, 21, 22, 24, 25, 27, 28, 33, 38, 39, 52, 70, 75, 83, 86, 88, 96], "simpl": [0, 3, 18, 20, 21, 43, 45, 46, 47, 52, 53, 55, 60, 65, 67, 75, 82, 84, 90, 100, 102, 105, 122, 144, 149, 153], "tool": [0, 3, 5, 21, 67, 74, 91, 153, 155], "descri": 0, "manual": [0, 43, 89, 139, 144], "vector": [0, 3, 4, 14, 16, 20, 21, 25, 26, 27, 28, 29, 31, 33, 38, 43, 46, 52, 61, 66, 70, 71, 72, 73, 74, 76, 82, 84, 88, 89, 90, 91, 94, 98, 105, 111, 113, 120, 124, 125, 143, 148], "n": [0, 4, 6, 7, 8, 11, 13, 14, 15, 17, 18, 19, 20, 21, 22, 24, 25, 26, 27, 28, 29, 31, 33, 38, 39, 42, 44, 45, 46, 47, 49, 55, 61, 65, 66, 67, 69, 70, 71, 72, 73, 74, 75, 78, 80, 81, 82, 84, 86, 88, 89, 90, 91, 92, 94, 97, 99, 106, 113, 115, 117, 120, 122, 124, 125, 130, 131, 132, 133, 136, 141, 142, 143, 144, 153, 156, 157, 159], "nb": 0, "sai": [0, 21, 72, 82, 122], "c_i": [0, 3, 21, 30], "sum_j": [0, 21, 52, 72, 82], "a_ib_": 0, "ij": [0, 3, 7, 10, 14, 15, 17, 21, 22, 25, 27, 33, 36, 39, 45, 46, 47, 49, 52, 66, 70, 71, 72, 80, 86, 106, 113, 144, 150], "singl": [0, 3, 9, 11, 12, 15, 20, 21, 24, 26, 28, 29, 33, 46, 47, 49, 67, 69, 71, 72, 73, 75, 76, 90, 91, 97, 104, 105, 108, 111, 113, 115, 117, 120, 121, 128, 133, 142, 143, 144, 146, 148, 149, 151], "12": [0, 2, 3, 6, 7, 14, 17, 20, 21, 22, 24, 27, 28, 31, 33, 39, 41, 44, 47, 52, 62, 67, 70, 72, 75, 76, 78, 81, 83, 86, 88, 89, 90, 94, 97, 98, 100, 101, 102, 105, 113, 120, 122, 124, 125, 131, 142, 143, 144, 148, 150, 153, 156], "36": [0, 20, 24, 70, 94, 100, 101, 120, 122, 125, 143, 156], "j": [0, 1, 3, 4, 7, 14, 15, 16, 17, 19, 20, 21, 22, 25, 27, 28, 29, 31, 33, 34, 36, 38, 39, 41, 44, 46, 47, 49, 55, 65, 67, 70, 71, 72, 76, 80, 82, 86, 89, 91, 97, 98, 100, 106, 120, 143, 144, 148, 150], "indic": [0, 3, 4, 17, 21, 25, 28, 33, 38, 42, 46, 52, 66, 70, 71, 72, 74, 76, 82, 86, 88, 91, 97, 98, 100, 108, 111, 142, 143], "letter": [0, 33, 46, 102], "them": [0, 3, 11, 21, 33, 43, 47, 52, 69, 74, 91, 113, 119, 120, 128, 131, 149, 154], "a_i": [0, 70], "multipli": [0, 3, 14, 15, 16, 27, 38, 41, 46, 49, 88, 91], "b_": [0, 11, 14, 45, 46, 52, 66, 82, 86, 91, 106, 113], "along": [0, 6, 11, 20, 28, 31, 38, 47, 60, 61, 64, 74, 82, 83, 88, 91, 92, 105, 113, 128, 131, 132, 139, 143, 150, 157], "hand": [0, 11, 18, 20, 21, 33, 43, 46, 49, 52, 55, 61, 72, 75, 82, 91, 122], "side": [0, 20, 21, 46, 47, 49, 60, 61, 65], "48": [0, 20, 76, 81, 86, 88, 90, 100, 101, 120, 122, 124, 125, 143, 156], "word": [0, 8, 16, 20, 22, 27, 71, 82, 88, 113], "repeat": [0, 33, 38, 55, 82, 91, 99, 153], "index": [0, 3, 25, 29, 33, 42, 47, 70, 74, 76, 81, 82, 86, 88, 89, 91, 94, 96, 100, 106, 113, 125, 142, 143, 144, 154, 156], "tell": [0, 43, 92, 101, 146], "dimens": [0, 3, 52, 71, 86, 94, 97, 106, 113, 133, 142, 148], "omit": [0, 25, 38], "simpler": [0, 3, 21, 46, 122, 143], "multipl": [0, 3, 20, 42, 46, 47, 70, 71, 75, 90, 94, 98, 101, 113, 120, 124, 125, 136, 143, 144, 148], "trace": [0, 38, 82, 84, 91, 153], "respect": [0, 3, 4, 6, 8, 12, 15, 16, 20, 21, 22, 24, 25, 26, 28, 31, 33, 36, 38, 41, 45, 46, 47, 48, 49, 50, 52, 55, 59, 60, 61, 66, 70, 71, 72, 73, 74, 76, 82, 83, 84, 88, 89, 91, 96, 97, 98, 100, 102, 103, 105, 111, 113, 117, 122, 130, 132, 133, 142, 143, 144, 150, 159], "integr": [0, 3, 5, 7, 9, 13, 19, 20, 21, 25, 29, 33, 39, 43, 46, 49, 53, 61, 67, 70, 71, 72, 75, 80, 82, 90, 99, 100, 101, 102, 113, 120, 124, 144], "would": [0, 3, 6, 14, 20, 21, 22, 45, 72, 75, 90, 101, 108, 120, 122, 125, 128, 132, 142, 143, 149, 153, 154, 156], "prefer": [0, 124], "kinet": [0, 16, 19, 20, 25, 39, 55, 70, 120, 125, 143, 148], "langl": [0, 3, 6, 11, 14, 15, 16, 20, 21, 22, 25, 26, 27, 28, 29, 30, 31, 33, 38, 39, 46, 49, 70, 71, 72, 75, 76, 78, 80, 82, 84, 86, 88, 89, 90, 91, 94, 96, 97, 98, 99, 100, 102, 111, 113, 122, 144, 146, 148, 150], "hat": [0, 3, 6, 7, 11, 15, 16, 19, 20, 21, 22, 25, 26, 27, 28, 29, 31, 33, 35, 38, 39, 46, 70, 72, 73, 75, 76, 78, 82, 84, 86, 88, 89, 90, 91, 94, 96, 97, 98, 99, 100, 102, 111, 113, 117, 122, 144, 146, 150], "t": [0, 1, 3, 7, 14, 16, 17, 19, 21, 22, 25, 26, 27, 28, 38, 39, 45, 46, 49, 52, 55, 60, 67, 70, 72, 74, 76, 78, 81, 82, 88, 89, 90, 91, 94, 97, 98, 99, 100, 106, 108, 111, 113, 122, 123, 143, 144, 148, 150, 153], "rangl": [0, 3, 6, 10, 11, 14, 15, 16, 19, 20, 21, 22, 25, 26, 27, 28, 29, 30, 31, 33, 38, 39, 46, 49, 70, 71, 72, 75, 76, 78, 80, 84, 86, 88, 89, 90, 91, 94, 96, 97, 98, 99, 100, 102, 105, 111, 113, 117, 122, 130, 144, 146, 148, 150], "sum_": [0, 3, 6, 7, 14, 15, 16, 17, 18, 19, 21, 22, 24, 25, 26, 27, 28, 29, 31, 33, 36, 38, 39, 41, 46, 49, 61, 66, 70, 71, 72, 73, 75, 78, 80, 82, 84, 86, 88, 89, 94, 96, 97, 99, 111, 117], "mathrm": [0, 3, 6, 7, 8, 10, 14, 15, 16, 17, 18, 19, 20, 21, 22, 24, 25, 26, 28, 29, 30, 35, 36, 38, 39, 40, 41, 45, 46, 47, 49, 52, 60, 61, 66, 70, 76, 78, 82, 86, 88, 90, 91, 94, 96, 97, 99, 100, 106, 111, 113, 122, 133, 150], "occ": [0, 17, 21, 22, 24, 25, 28, 29, 33, 70, 86, 88, 90, 94, 97, 111, 113, 142], "t_": [0, 19, 22, 33, 46, 70, 72, 82, 94], "ii": [0, 3, 7, 21, 24, 25, 29, 39, 46, 66, 67, 88, 89, 159], "info": [0, 20, 21, 42, 62, 70, 72, 76, 89, 98, 100, 120, 125, 143, 148], "opt": [0, 20, 21, 100, 120, 125, 143, 148], "miniconda3": [0, 20, 21, 100, 120, 125, 143, 148], "env": [0, 20, 21, 42, 100, 120, 125, 143, 148], "lib": [0, 20, 21, 100, 120, 125, 143, 148], "python3": [0, 20, 21, 100, 120, 125, 143, 148], "site": [0, 20, 21, 39, 100, 120, 125, 139, 142, 143, 148, 149, 159], "1p": [0, 20, 24, 70, 90, 101, 120, 122, 124, 125, 143, 148], "3p": [0, 120, 143, 144], "21": [0, 14, 20, 31, 43, 62, 67, 70, 71, 72, 89, 90, 92, 100, 101, 120, 122, 124, 125, 143, 144, 148, 149, 150, 156], "kin_drv": [0, 22, 25], "kineticenergyintegralsdriv": [0, 3, 7, 14, 17, 21, 22, 25, 39], "t_ao": [0, 22, 25], "to_numpi": [0, 3, 7, 14, 17, 21, 22, 25, 33, 39], "coeffici": [0, 3, 8, 9, 10, 13, 14, 17, 18, 21, 22, 25, 26, 33, 39, 46, 49, 72, 75, 76, 80, 96, 98, 99, 105, 113, 141, 144, 148, 150], "nocc": [0, 7, 10, 14, 17, 22, 25, 28, 38, 39, 70, 81, 86, 88, 94, 96, 106, 113, 115, 142, 143, 144], "number_of_alpha_electron": [0, 10, 14, 17, 22, 25, 28, 38, 39, 70, 81, 86, 88, 94, 96, 106, 113, 115, 142, 143, 144], "c_alpha": [0, 13, 17, 18, 24, 25, 26, 28, 33, 38, 70, 81, 86, 88, 96, 113, 144], "pq": [0, 3, 17, 21, 24, 28, 29, 33, 46, 49, 70, 72, 73, 75, 86, 88, 97, 111, 150], "p": [0, 1, 3, 6, 7, 11, 17, 18, 21, 24, 25, 26, 27, 28, 29, 30, 33, 38, 40, 46, 49, 60, 67, 70, 72, 76, 78, 82, 88, 89, 91, 96, 97, 98, 99, 100, 120, 133, 148, 150, 154], "q": [0, 3, 11, 17, 21, 24, 28, 29, 33, 36, 38, 40, 45, 46, 49, 52, 60, 66, 70, 72, 82, 84, 88, 91, 97, 100], "_": [0, 3, 4, 7, 11, 15, 17, 18, 20, 21, 22, 24, 25, 26, 27, 28, 29, 30, 31, 35, 38, 39, 40, 45, 46, 49, 55, 60, 62, 66, 70, 71, 72, 73, 75, 76, 78, 80, 82, 83, 84, 86, 88, 89, 90, 91, 94, 96, 97, 98, 100, 111, 113, 115, 117, 136, 143, 153], "c_": [0, 3, 7, 8, 15, 17, 19, 24, 26, 28, 33, 38, 39, 46, 49, 71, 80, 82, 91, 96, 106, 113, 144], "mathbf": [0, 3, 4, 6, 7, 8, 10, 14, 15, 16, 17, 18, 19, 21, 24, 25, 26, 28, 29, 30, 31, 36, 38, 39, 40, 45, 46, 49, 52, 55, 60, 61, 66, 70, 71, 72, 73, 74, 80, 82, 84, 86, 88, 91, 94, 97, 100, 106, 111, 113, 150, 153], "real": [0, 3, 10, 15, 43, 46, 47, 49, 55, 67, 76, 83, 86, 91, 94, 97, 98, 99, 113, 143, 144], "ignor": [0, 25, 26, 70, 73, 82, 144], "complex": [0, 3, 15, 20, 21, 31, 33, 35, 39, 43, 47, 53, 67, 76, 82, 83, 86, 97, 98, 99, 111, 124, 142, 143, 144, 147, 149, 159], "conjug": [0, 3, 15, 25, 46, 89, 97, 98, 99, 102, 111, 144], "know": [0, 3, 20, 61, 92, 122], "how": [0, 3, 4, 12, 18, 20, 21, 27, 43, 46, 47, 50, 51, 52, 53, 55, 56, 57, 61, 65, 68, 70, 73, 78, 82, 90, 91, 93, 96, 101, 102, 103, 121, 123, 125, 126, 131, 132, 137, 140, 141, 142, 143, 144, 146, 148, 151, 154, 155, 156], "slice": 0, "extract": [0, 21, 22, 33, 47, 70, 76, 113, 117, 124, 142, 144, 145, 156], "orbital_energi": [0, 113, 143, 144, 145], "e_alpha": [0, 13, 33, 70, 86, 113, 143, 144, 145], "20": [0, 10, 13, 14, 20, 24, 28, 33, 34, 36, 41, 43, 47, 60, 62, 65, 67, 70, 72, 86, 89, 90, 101, 105, 120, 122, 124, 125, 130, 131, 143, 144, 145, 148, 156], "24238972": 0, "26646064": 0, "61558541": 0, "45278475": 0, "39106556": 0, "60181634": 0, "73720765": 0, "To": [0, 3, 4, 10, 14, 16, 17, 18, 19, 21, 25, 27, 33, 36, 38, 39, 41, 45, 46, 49, 52, 65, 71, 72, 82, 96, 101, 106, 122, 124, 127, 130, 131, 132, 139, 144, 145, 146, 148, 150, 153, 154, 156, 159], "unoccupi": [0, 4, 15, 18, 22, 29, 31, 46, 72, 86, 94, 96, 111, 113, 115, 128, 141, 142, 143, 144, 149, 150], "splice": 0, "look": [0, 3, 20, 21, 33, 43, 47, 65, 70, 72, 75, 90, 113, 120, 122, 125, 126, 131, 133, 139, 143, 145, 148, 153, 157, 159], "guid": [0, 43, 67, 120, 128, 133, 149], "interchang": 0, "becom": [0, 3, 4, 8, 10, 11, 14, 15, 16, 18, 19, 20, 21, 24, 25, 26, 27, 28, 29, 33, 41, 46, 47, 52, 55, 60, 74, 76, 82, 83, 88, 92, 94, 97, 101, 102, 103, 120, 122, 142, 143, 144, 149], "t_mo": 0, "ap": [0, 17, 22, 24, 28, 38, 46, 67, 86, 88], "bq": [0, 17, 22, 24, 28, 38, 86, 88], "ab": [0, 3, 5, 6, 7, 8, 17, 18, 19, 22, 24, 25, 27, 28, 33, 38, 39, 46, 49, 52, 67, 68, 70, 72, 80, 81, 83, 86, 88, 96, 99, 106, 113, 120, 122, 125, 139, 142, 143, 150, 153], "t_exp": 0, "3f": [0, 3, 24, 33, 47, 70, 75, 83, 113, 124, 144, 150, 151], "579": [0, 90], "hermitian": [0, 15, 24, 46, 68, 70, 72, 86, 97, 111, 113], "linalg": [0, 3, 7, 10, 14, 21, 24, 27, 33, 38, 39, 52, 60, 70, 81, 86, 94, 97, 99, 106, 113, 115, 148, 153], "eigh": [0, 3, 7, 10, 14, 24, 27, 39, 70, 81, 115, 153], "pair": [0, 3, 21, 23, 29, 38, 47, 71, 72, 73, 86, 90, 92, 94, 101, 113, 120, 124, 139], "s_": [0, 24, 26, 46, 49, 61, 72, 82, 96, 105, 117, 144, 153], "chi_": [0, 6, 7, 17, 18, 26, 28, 36, 38, 41, 46, 49, 82, 91], "round": 0, "237": [0, 26, 65], "053": [0, 3], "472": 0, "25": [0, 10, 14, 18, 20, 24, 27, 28, 38, 47, 59, 60, 62, 65, 70, 76, 86, 89, 90, 91, 100, 101, 120, 122, 124, 125, 130, 131, 132, 133, 136, 137, 139, 142, 143, 154, 156, 159], "24": [0, 3, 7, 10, 13, 14, 17, 20, 24, 44, 62, 65, 76, 83, 89, 90, 91, 98, 101, 120, 124, 125, 133, 143, 156], "orthogon": [0, 7, 20, 21, 33, 46, 66, 70, 72, 80, 101, 120, 125, 143, 148], "diagon": [0, 3, 4, 12, 15, 21, 24, 27, 33, 38, 41, 43, 46, 50, 66, 69, 71, 72, 73, 75, 84, 86, 88, 89, 94, 97, 113, 115, 120, 130, 139, 148, 153, 156], "diag": [0, 22, 27, 38, 52, 70, 139, 153], "dagger": [0, 3, 10, 11, 14, 15, 17, 21, 24, 25, 26, 28, 29, 30, 33, 38, 46, 61, 66, 70, 71, 72, 73, 75, 80, 86, 88, 97, 111, 113, 144, 150, 153], "column": [0, 10, 11, 21, 66, 72, 94, 113], "345": 0, "42": [0, 20, 65, 67, 76, 81, 97, 100, 101, 120, 122, 124, 143, 148, 156], "886": 0, "093": 0, "331": 0, "926": [0, 120], "18": [0, 7, 14, 20, 24, 25, 27, 34, 36, 41, 62, 67, 72, 84, 90, 91, 101, 113, 115, 120, 122, 124, 125, 129, 131, 143, 148, 150, 156], "713": 0, "644": [0, 70], "209": [0, 120, 156], "695": 0, "279": [0, 67, 90, 124], "313": 0, "584": 0, "437": [0, 90], "564": 0, "145": [0, 3, 36, 67], "131": [0, 72, 113, 156], "426": 0, "52": [0, 20, 24, 70, 90, 94, 101, 120, 122, 143, 148, 156], "321": 0, "609": 0, "673": [0, 136], "27": [0, 14, 20, 24, 44, 62, 70, 75, 81, 90, 101, 102, 105, 106, 113, 115, 120, 122, 124, 125, 143, 144, 145, 148, 150, 151, 156], "602": [0, 144, 150], "798": 0, "matmul": [0, 7, 14, 21, 38, 52, 81, 86, 88, 99, 106, 113, 144, 148], "s_diag": 0, "verifi": [0, 3, 10, 39, 92, 113, 126], "ident": [0, 3, 6, 11, 15, 24, 25, 27, 28, 29, 33, 36, 38, 41, 46, 88, 97, 106, 113, 122, 126, 148], "len": [0, 2, 3, 7, 14, 29, 38, 47, 52, 62, 70, 81, 99, 106, 113, 124, 125, 130, 131, 132, 139, 142, 143, 144, 148, 151, 156], "abs_diff": 0, "absolut": [0, 4, 18, 33, 76, 120, 124, 125, 126, 139, 142, 143, 144, 146, 149], "4e": [0, 3, 20, 75, 90, 101, 120, 124], "7195e": 0, "15": [0, 7, 14, 17, 18, 20, 21, 25, 26, 28, 33, 62, 67, 70, 72, 75, 76, 82, 90, 99, 101, 113, 120, 123, 124, 125, 130, 131, 132, 143, 144, 148, 150, 156, 157, 159], "item": 0, "arrang": [0, 38, 82], "kei": [0, 2, 5, 13, 22, 45, 46, 58, 76, 89, 98, 100, 108, 113, 131, 150], "some_dict": 0, "fruit": [0, 43], "appl": 0, "nprint": 0, "dict_kei": [0, 13, 58, 100, 113], "dict_valu": 0, "green": [0, 18, 73, 105], "fresh": 0, "ripe": 0, "width": [0, 18, 31, 39, 47, 59, 62, 65, 70, 73, 90, 92, 99, 100, 106, 120, 124, 130, 131, 132, 133, 136, 137, 139, 144, 154, 156, 157, 159], "height": [0, 18, 39, 47, 59, 62, 65, 67, 70, 90, 92, 124, 130, 131, 132, 133, 136, 137, 139, 154, 156, 157, 159], "check": [0, 3, 21, 33, 42, 50, 52, 60, 62, 72, 92, 133, 144], "str": [0, 8, 18, 20, 21, 29, 33, 47, 52, 72, 92, 105, 113, 120, 124, 125, 142, 144, 145, 148, 151, 153], "int": [0, 6, 15, 16, 18, 19, 20, 25, 28, 29, 30, 36, 40, 46, 49, 66, 67, 91, 94, 106, 148, 150], "fals": [0, 10, 14, 27, 33, 39, 52, 62, 65, 70, 72, 94, 105, 122, 131, 133, 136, 139, 153, 157, 159], "certain": [0, 82, 128, 143, 144, 149], "compos": [0, 11, 16, 27, 60, 66, 74, 82], "angl": [0, 4, 8, 11, 45, 52, 53, 58, 82, 100, 130, 142, 150], "radian": 0, "degre": [0, 4, 26, 45, 52, 58, 66, 129, 147], "2f": [0, 7, 21, 33, 44, 65, 70, 99, 105, 131, 144, 156], "45": [0, 20, 24, 39, 61, 67, 70, 76, 81, 90, 100, 101, 120, 122, 124, 125, 131, 143, 148, 150, 156, 157], "785": [0, 67], "chosen": [0, 3, 7, 8, 27, 34, 38, 49, 55, 82, 83, 84, 91, 96, 122, 124, 133, 144], "high": [0, 20, 38, 41, 42, 43, 55, 67, 75, 101, 106, 120, 124, 128, 130, 136, 142, 143, 144, 148, 149], "interfac": [0, 43, 59, 133], "layer": [0, 18, 36, 41, 43], "account": [0, 4, 8, 19, 33, 35, 40, 46, 47, 60, 61, 69, 71, 72, 76, 82, 89, 136, 143, 144, 149, 150], "its": [0, 3, 5, 9, 11, 15, 16, 19, 21, 22, 26, 33, 39, 43, 45, 46, 47, 49, 52, 55, 60, 61, 69, 71, 73, 74, 82, 84, 88, 89, 91, 98, 100, 101, 103, 113, 122, 124, 144, 149, 154, 156], "eas": [0, 43, 83, 142, 148], "framework": [0, 11, 20, 43, 67, 101, 143, 144], "intermingl": 0, "unfamiliar": 0, "wealth": [0, 54], "resourc": [0, 55, 133], "accomod": 0, "w3school": 0, "host": 0, "comprehens": [0, 43], "project": [0, 17, 27, 31, 42, 43, 60, 66, 130, 133, 144], "test": [0, 3, 17, 28, 33, 82, 86, 106], "page": [0, 3, 13, 43, 67, 68, 102], "prepar": [0, 60, 124, 132, 142, 144, 148, 151], "lesson": 0, "video": 0, "document": [0, 43, 80], "galleri": 0, "dedic": 0, "teach": [0, 1, 43, 148], "chemist": [0, 17, 22, 25, 29, 70, 78, 150], "jupyterhub": 0, "serv": [0, 12, 17, 43, 52, 78, 103, 143], "instruct": [0, 88], "deploi": 0, "cloud": 0, "seaborn": 0, "publish": [1, 91], "creativ": 1, "common": [1, 3, 10, 15, 22, 24, 25, 31, 47, 64, 82, 84, 105, 122, 133, 141, 143, 145, 153], "sharealik": 1, "licens": 1, "cc": [1, 2, 4, 6, 7, 8, 10, 13, 14, 17, 18, 20, 22, 24, 25, 26, 28, 33, 39, 44, 58, 59, 72, 78, 92, 106, 113, 120, 122, 128, 133, 143, 144, 149, 157], "BY": 1, "sa": [1, 90, 92, 101, 124], "fransson": [1, 67], "delcei": 1, "brumboiu": [1, 67], "hodeck": [1, 67], "li": [1, 46, 67, 70, 72, 82, 83], "rinkeviciu": [1, 67], "z": [1, 6, 8, 11, 17, 18, 20, 21, 28, 31, 33, 38, 45, 49, 52, 60, 61, 67, 70, 75, 76, 78, 82, 83, 84, 86, 88, 89, 90, 91, 96, 98, 101, 105, 111, 113, 120, 124, 131, 142, 143, 144, 146, 148, 149, 150, 151, 156, 157], "dreuw": [1, 67, 70], "rhee": [1, 67], "norman": [1, 67], "laptop": [1, 43, 147], "hpc": [1, 17, 42, 43, 68], "notebook": [1, 13, 38, 43, 47, 102, 119, 137, 140, 153, 154, 156, 157], "explor": [1, 9, 18, 43, 56, 65, 119], "kth": 1, "royal": [1, 67], "institut": 1, "technologi": 1, "stockholm": 1, "2022": [1, 67, 156], "doi": [1, 67], "30746": 1, "978": [1, 67, 90, 101, 124], "91": [1, 20, 67, 76, 100, 120, 143, 156], "988114": 1, "us": [1, 2, 3, 4, 5, 6, 7, 9, 10, 11, 12, 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, 25, 26, 27, 28, 29, 35, 36, 37, 38, 39, 42, 43, 44, 45, 46, 47, 48, 49, 51, 52, 53, 54, 55, 57, 58, 59, 60, 61, 62, 64, 65, 66, 67, 69, 70, 72, 73, 74, 75, 76, 78, 82, 83, 84, 86, 88, 89, 90, 91, 92, 93, 94, 96, 97, 98, 99, 100, 101, 102, 104, 105, 108, 109, 111, 113, 117, 118, 120, 122, 123, 124, 125, 126, 128, 131, 132, 136, 137, 139, 140, 141, 142, 143, 144, 145, 146, 147, 148, 149, 150, 152, 153, 154, 156, 159], "articl": [1, 67, 153], "didact": 1, "aspect": [1, 18, 22, 49, 68, 72, 74, 104, 113, 129, 136, 141, 147], "chem": [1, 34, 36, 41, 67, 70, 76, 89, 98, 148], "educ": [1, 43], "1664": [1, 156], "1671": [1, 156], "2023": [1, 156], "1021": [1, 67, 156], "ac": [1, 46, 67, 72, 76], "jcheme": 1, "2c01103": 1, "appreci": [1, 143], "suggest": [1, 3, 20, 21, 43, 72, 123, 128, 148, 149], "materi": [1, 67, 69, 82, 91], "present": [1, 9, 14, 18, 20, 23, 32, 35, 36, 43, 59, 69, 102, 103, 105, 108, 130, 133, 136, 143, 148, 149], "hesit": 1, "reach": [1, 3, 5, 7, 14, 18, 19, 20, 21, 38, 57, 60, 69, 72, 75, 90, 96, 97, 101, 105, 120, 122, 124], "author": [1, 82, 128, 136, 149, 150], "open": [1, 11, 13, 20, 24, 39, 42, 62, 70, 92, 122, 132, 133, 139, 148, 154, 156, 157], "github": [1, 42, 43], "section": [1, 3, 5, 9, 12, 20, 21, 22, 23, 30, 32, 33, 35, 37, 39, 40, 43, 46, 48, 49, 51, 54, 55, 56, 57, 60, 61, 63, 66, 67, 69, 70, 72, 75, 82, 91, 93, 94, 101, 103, 105, 117, 122, 123, 124, 125, 129, 130, 131, 133, 137, 139, 140, 142, 143, 144, 147, 148, 150, 151, 153, 154, 155, 156], "miss": [1, 143], "contribut": [1, 3, 8, 19, 21, 24, 33, 38, 39, 40, 46, 49, 61, 65, 72, 74, 80, 84, 88, 89, 90, 96, 103, 113, 133, 141, 143], "exchang": [2, 3, 5, 6, 7, 15, 18, 25, 26, 31, 33, 46, 47, 49, 67, 73, 76, 80, 89, 98, 105, 111, 117, 137, 143, 144, 148, 149], "correl": [2, 3, 5, 6, 7, 9, 17, 18, 23, 33, 43, 46, 49, 67, 69, 72, 75, 76, 80, 92, 98, 101, 105, 121, 122, 124, 128, 136, 137, 143, 144, 147, 148, 149], "calcul": [2, 3, 5, 9, 17, 18, 19, 20, 21, 22, 24, 28, 34, 36, 37, 40, 41, 43, 46, 47, 48, 49, 50, 51, 52, 55, 59, 60, 61, 62, 66, 67, 68, 71, 76, 78, 80, 82, 84, 88, 89, 92, 96, 98, 99, 100, 101, 104, 105, 106, 108, 109, 111, 113, 117, 120, 122, 123, 124, 125, 128, 129, 130, 131, 134, 137, 139, 141, 142, 143, 145, 146, 147, 149, 152, 153, 156, 157], "electron": [2, 5, 6, 7, 8, 9, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 24, 27, 28, 33, 36, 38, 39, 40, 43, 44, 45, 46, 47, 49, 58, 59, 61, 65, 67, 68, 69, 70, 72, 73, 74, 76, 78, 80, 82, 83, 90, 91, 94, 96, 98, 100, 101, 102, 103, 105, 106, 111, 115, 120, 122, 123, 124, 125, 129, 130, 132, 136, 140, 141, 143, 144, 148], "helium": [2, 4, 8, 67, 76], "hf": [2, 3, 4, 7, 8, 12, 14, 15, 20, 21, 22, 24, 50, 52, 70, 75, 80, 90, 92, 97, 105, 106, 113, 120, 131, 132, 137, 142, 144, 145, 146, 149, 156], "second": [2, 3, 4, 7, 8, 9, 17, 19, 21, 22, 26, 32, 33, 34, 36, 40, 41, 45, 46, 47, 50, 52, 55, 60, 61, 64, 66, 67, 72, 73, 74, 75, 82, 83, 84, 88, 89, 91, 98, 100, 101, 111, 113, 115, 117, 120, 122, 130, 141, 148, 149, 150], "m\u00f8ller": [2, 9, 17, 32, 43, 46, 68, 70, 73], "plesset": [2, 9, 17, 32, 43, 46, 68, 70, 73], "configur": [2, 4, 20, 21, 24, 25, 32, 38, 39, 42, 43, 46, 47, 52, 67, 69, 72, 90, 97, 101, 102, 105, 115, 118, 120, 122, 124, 125, 128, 131, 143, 148, 149, 154, 156], "kohn": [2, 5, 6, 7, 12, 20, 40, 43, 46, 49, 67, 100, 108, 111, 122, 137, 148], "sham": [2, 5, 6, 7, 12, 20, 40, 43, 46, 49, 67, 100, 108, 111, 122, 137, 148], "theori": [2, 4, 7, 9, 12, 16, 17, 19, 22, 23, 28, 33, 34, 36, 38, 41, 43, 44, 46, 47, 49, 50, 52, 56, 58, 59, 65, 67, 68, 69, 70, 72, 73, 76, 80, 88, 90, 93, 96, 98, 99, 102, 103, 104, 105, 108, 109, 113, 124, 128, 132, 137, 139, 141, 143, 144, 145, 148, 149, 153], "multipsi": [2, 3, 4, 17, 20, 21, 22, 24, 33, 43, 75, 90, 92, 101, 120, 122, 124, 144, 157], "mtp": [2, 3, 4, 20, 21, 22, 24, 33, 75, 90, 92, 101, 120, 122, 124, 144, 157], "read_molecule_str": [2, 4, 20, 21, 28, 33, 38, 47, 52, 92, 100, 106, 120, 122, 124, 142, 143, 145, 148, 157], "he": [2, 4, 8, 18, 67, 89], "000": [2, 3, 20, 24, 70, 78, 90, 101, 120, 122, 124, 125, 130, 143, 148, 150], "basi": [2, 6, 7, 9, 12, 13, 17, 18, 20, 21, 24, 25, 28, 30, 33, 34, 36, 38, 39, 41, 43, 46, 47, 49, 52, 61, 65, 67, 70, 72, 75, 76, 78, 83, 86, 88, 90, 91, 92, 94, 96, 97, 98, 99, 100, 101, 102, 105, 106, 113, 115, 117, 120, 122, 124, 125, 126, 130, 131, 132, 136, 137, 139, 141, 142, 144, 145, 148, 151, 153, 157], "pvtz": [2, 4, 8, 26, 143, 144, 149], "mp2_drv": [2, 8, 22], "mp2driver": [2, 8, 22, 33, 144], "mp2_result": [2, 8, 22], "mp2_energi": [2, 8, 22], "orbspac": [2, 3, 4, 20, 21, 22, 24, 33, 75, 90, 101, 120, 122, 124, 144], "ci_drv": [2, 3, 4, 22, 33, 120], "cidriv": [2, 3, 4, 20, 21, 22, 33, 75, 101, 120], "ci_result": [2, 3, 4, 20, 21, 22, 33, 75, 101, 120], "get_energi": [2, 3, 4, 20, 21, 22, 24, 92, 101, 120, 122], "xcfun": [2, 6, 7, 18, 20, 47, 65, 76, 83, 89, 94, 98, 100, 102, 105, 106, 115, 122, 124, 136, 137, 142, 144, 148, 151, 153], "available_funct": 2, "16": [2, 3, 7, 14, 18, 20, 21, 22, 24, 39, 62, 67, 70, 72, 76, 78, 83, 90, 94, 101, 105, 120, 122, 123, 124, 125, 143, 144, 156], "8f": [2, 4, 6, 7, 14, 18, 21, 22, 24, 27, 39, 86, 88, 122], "86115334": 2, "89429091": 2, "90023217": 2, "slater": [2, 3, 7, 11, 12, 15, 19, 20, 21, 28, 33, 38, 46, 80, 108, 111, 122, 143, 149, 150], "72271178": 2, "slda": 2, "87143717": 2, "b88x": 2, "86247050": 2, "blyp": [2, 20, 126], "90621759": 2, "b3lyp": [2, 6, 18, 19, 47, 62, 65, 67, 76, 83, 89, 98, 100, 105, 106, 115, 122, 124, 126, 128, 136, 137, 142, 143, 144, 146, 148, 149, 151, 153], "91450655": 2, "bhandh": 2, "83473781": 2, "bhandhlyp": [2, 94, 102, 105, 126], "90514866": 2, "pbe": [2, 19, 143], "89213590": 2, "pbe0": 2, "89451563": 2, "revpb": 2, "90710482": 2, "bp86": 2, "90557480": 2, "pw91": 2, "89919908": 2, "mpw1k": 2, "90521521": 2, "olyp": 2, "90644600": 2, "o3lyp": 2, "90951647": 2, "x3lyp": 2, "90758515": 2, "b97": 2, "90931588": 2, "90639481": 2, "90940855": 2, "91133188": 2, "tpss": [2, 19], "90886838": 2, "tpssh": 2, "90836089": 2, "revtpss": 2, "91132827": 2, "pkzb": 2, "90387499": 2, "scan": [2, 20, 21, 47, 62, 64, 92, 100, 120], "90431544": 2, "rscan": 2, "r2scan": 2, "m05": 2, "90471113": 2, "2x": 2, "90804370": 2, "m06": [2, 19, 67], "90925996": 2, "90399052": 2, "90187434": 2, "91319059": 2, "m11": 2, "91833797": 2, "mpw1b95": 2, "90141905": 2, "mpwb1k": 2, "90163660": 2, "pw6b95": 2, "91673962": 2, "pwb6k": 2, "90888490": 2, "fig": [2, 7, 18, 20, 28, 58, 59, 60, 65, 69, 96, 99, 100, 113, 123, 124, 129, 157], "ax": [2, 7, 11, 18, 20, 31, 46, 58, 59, 60, 66, 67, 74, 76, 82, 88, 96, 98, 99, 100, 150], "subplot": [2, 3, 20, 28, 58, 59, 62, 99, 100, 113, 124, 142, 143, 144, 151], "enumer": [2, 3, 24, 33, 38, 39, 44, 81, 83, 105, 122], "set_xtick": [2, 18], "rang": [2, 3, 4, 7, 12, 14, 18, 20, 21, 22, 24, 27, 28, 29, 31, 33, 35, 38, 39, 43, 52, 62, 67, 70, 75, 76, 81, 86, 88, 92, 97, 99, 100, 101, 106, 113, 120, 124, 125, 128, 130, 131, 132, 136, 143, 144, 148, 149, 151, 156], "xtick": [2, 3, 4, 7, 27, 31, 75, 96, 101, 113, 143], "90": [2, 20, 47, 62, 70, 90, 92, 120, 130, 132, 143, 150, 156, 159], "set_ylim": [2, 20, 100], "93": [2, 20, 67, 100, 101, 120, 143, 144, 156], "82": [2, 3, 20, 67, 101, 122, 143, 156], "conceptu": 3, "computation": [3, 5, 38, 47, 72, 144, 149], "simplest": [3, 21, 46, 55, 60, 89, 129], "solv": [3, 14, 15, 16, 25, 33, 38, 41, 43, 45, 46, 47, 49, 71, 75, 100, 106, 108, 111, 113, 120, 148, 150], "schr\u00f6dinger": [3, 9, 16, 22, 25, 47, 108, 150], "simpli": [3, 20, 43, 47, 49, 61, 66, 70, 75, 91, 99, 101, 120, 124, 131, 133, 153], "expand": [3, 15, 21, 22, 24, 26, 27, 30, 46, 49, 70, 71, 72, 73, 86, 88, 89, 91, 96, 100, 108, 111, 122], "mani": [3, 6, 9, 11, 12, 15, 17, 19, 21, 27, 33, 43, 46, 47, 53, 60, 67, 70, 72, 73, 92, 98, 101, 106, 133, 142, 143, 144, 149, 153], "bodi": [3, 21, 53, 67, 72, 73, 144], "wave": [3, 4, 6, 9, 12, 13, 15, 16, 17, 20, 22, 24, 25, 27, 29, 31, 33, 39, 43, 46, 67, 70, 72, 75, 76, 80, 82, 84, 86, 88, 90, 96, 97, 99, 100, 102, 103, 111, 117, 120, 122, 125, 128, 144, 148, 149], "function": [3, 4, 6, 7, 8, 9, 10, 12, 13, 14, 15, 16, 17, 21, 22, 23, 24, 25, 27, 28, 29, 31, 33, 39, 41, 42, 43, 46, 47, 49, 54, 55, 60, 62, 65, 67, 70, 72, 73, 75, 76, 78, 80, 81, 82, 83, 84, 90, 91, 94, 96, 97, 98, 100, 102, 103, 104, 105, 108, 111, 113, 117, 120, 122, 124, 125, 128, 130, 131, 133, 137, 139, 142, 144, 145, 146, 148, 149, 152, 154, 156, 157, 159], "set": [3, 9, 11, 12, 13, 15, 16, 17, 18, 20, 21, 22, 24, 25, 27, 29, 30, 31, 33, 36, 38, 40, 42, 43, 45, 46, 47, 49, 51, 52, 55, 60, 61, 66, 67, 70, 72, 74, 75, 78, 82, 83, 90, 91, 92, 96, 98, 100, 101, 103, 106, 111, 113, 115, 117, 120, 122, 124, 125, 126, 130, 131, 132, 136, 137, 139, 141, 142, 144, 145, 148, 151, 153, 154, 157], "psi_": [3, 11, 15, 19, 20, 21, 22, 25, 26, 27, 28, 29, 30, 31, 80, 97, 100, 122], "sum_k": [3, 16, 25, 46, 82], "c_k": 3, "k": [3, 4, 7, 10, 14, 15, 16, 17, 19, 20, 22, 25, 27, 29, 31, 33, 39, 44, 46, 47, 60, 61, 65, 66, 67, 69, 70, 71, 72, 81, 82, 84, 89, 99, 100, 106, 120, 124, 125, 130, 132, 141, 142, 143, 144, 148, 149, 150, 151, 153], "energi": [3, 7, 9, 10, 12, 13, 16, 19, 20, 21, 24, 25, 31, 35, 43, 44, 45, 47, 48, 49, 50, 51, 55, 56, 57, 58, 59, 60, 61, 62, 64, 66, 67, 69, 70, 71, 73, 75, 76, 78, 84, 88, 89, 90, 91, 92, 96, 98, 99, 100, 101, 102, 104, 105, 106, 108, 111, 115, 117, 120, 122, 123, 124, 125, 126, 129, 130, 134, 137, 141, 142, 143, 144, 145, 146, 149, 150, 151, 153, 156], "e_": [3, 4, 7, 8, 15, 18, 19, 22, 27, 35, 39, 40, 46, 47, 49, 82, 91, 100, 143, 150], "There": [3, 5, 11, 20, 29, 36, 46, 60, 75, 88, 92, 94, 122, 124, 144], "redund": [3, 45, 60, 67, 90], "constant": [3, 16, 38, 47, 50, 55, 60, 73, 76, 89, 91, 99, 100, 143, 144, 150, 156], "doe": [3, 4, 11, 14, 16, 21, 30, 42, 47, 55, 65, 72, 74, 75, 84, 89, 92, 97, 98, 99, 121, 122, 126, 128, 131, 142, 143, 144, 146, 148, 149, 153], "thu": [3, 15, 20, 21, 22, 28, 29, 33, 39, 40, 42, 46, 47, 53, 61, 66, 69, 72, 73, 75, 76, 82, 83, 89, 90, 91, 92, 98, 101, 102, 113, 120, 122, 123, 124, 128, 130, 133, 139, 141, 142, 143, 144, 147, 148, 149, 153, 157], "normal": [3, 22, 26, 27, 31, 33, 38, 43, 46, 47, 50, 52, 61, 66, 86, 88, 89, 111, 113, 130, 131, 132, 144, 151], "lagrangian": [3, 14, 16, 34, 36, 38, 46, 61, 67], "epsilon": [3, 7, 10, 14, 33, 39, 47, 86, 89, 99, 100], "gradient": [3, 20, 21, 33, 38, 43, 45, 47, 49, 50, 52, 57, 64, 66, 67, 70, 82, 90, 101, 106, 111, 120, 124, 125, 129, 130, 131, 132, 143, 148, 150], "sum_i": [3, 16, 19, 21, 28, 29, 30, 40, 46, 52, 70, 80, 84, 90, 91, 111, 144], "denot": [3, 11, 25, 26, 29, 33, 45, 46, 60, 66, 72, 80, 82, 83, 102, 113, 150], "express": [3, 6, 8, 10, 15, 19, 20, 21, 24, 25, 26, 28, 30, 31, 33, 38, 43, 45, 46, 47, 55, 61, 70, 71, 73, 76, 80, 82, 84, 88, 89, 91, 99, 100, 108, 109, 111, 117, 124, 139, 150], "recast": 3, "equival": [3, 8, 11, 17, 20, 21, 28, 33, 36, 38, 41, 46, 49, 72, 91, 100, 120, 122, 141, 143, 150], "eigenvalu": [3, 15, 45, 46, 52, 60, 64, 65, 66, 70, 72, 90, 99, 102, 105, 106, 113, 115, 122, 124, 130, 132, 144, 148, 151, 153], "possibl": [3, 4, 5, 8, 11, 16, 29, 33, 38, 43, 47, 50, 53, 55, 70, 72, 73, 83, 91, 99, 109, 111, 123, 124, 128, 133, 144, 148, 150, 157], "state": [3, 5, 6, 7, 10, 12, 13, 15, 16, 18, 19, 20, 21, 24, 25, 26, 27, 28, 31, 34, 36, 41, 43, 45, 48, 49, 51, 55, 56, 60, 67, 68, 69, 73, 74, 75, 76, 78, 81, 82, 86, 88, 89, 90, 91, 92, 93, 94, 96, 98, 99, 102, 103, 104, 105, 106, 108, 111, 113, 115, 117, 118, 120, 121, 123, 124, 125, 128, 129, 130, 131, 132, 136, 141, 142, 143, 147, 149, 150, 151, 158], "ground": [3, 10, 13, 15, 16, 18, 19, 20, 21, 22, 27, 33, 43, 49, 51, 65, 67, 70, 72, 73, 75, 78, 80, 89, 90, 92, 99, 100, 101, 102, 108, 120, 122, 123, 124, 125, 129, 130, 131, 136, 143, 147, 148, 150], "correspond": [3, 7, 14, 17, 20, 21, 22, 27, 29, 33, 38, 39, 45, 46, 47, 49, 52, 55, 60, 61, 66, 67, 69, 70, 71, 72, 73, 74, 75, 76, 82, 84, 89, 90, 91, 92, 98, 100, 101, 108, 111, 113, 115, 120, 122, 124, 130, 133, 136, 139, 142, 149, 153, 156], "lowest": [3, 15, 18, 21, 31, 33, 44, 72, 75, 90, 91, 92, 97, 100, 102, 113, 115, 122, 124, 125, 142, 144, 145, 153], "principl": [3, 5, 14, 16, 67, 72, 82, 99, 101, 111, 113, 122, 124, 133, 147], "infinit": [3, 15, 16, 20, 46], "choos": [3, 13, 20, 27, 43, 46, 80, 82, 144, 145, 150], "ideal": [3, 20, 101, 150], "expans": [3, 20, 21, 26, 33, 38, 47, 49, 52, 55, 70, 72, 73, 75, 76, 82, 84, 90, 91, 96, 98, 99, 100, 101, 111, 120, 124], "quickli": [3, 47], "compact": [3, 15, 72, 82, 86, 94, 125, 141, 143, 153], "easili": [3, 20, 27, 46, 47, 52, 55, 60, 72, 82, 106, 120, 142, 144], "manipul": [3, 21, 29, 62, 157], "effici": [3, 33, 43, 46, 47, 49, 67, 89, 91, 103], "unfortun": [3, 71], "criteria": [3, 19, 55], "oppos": [3, 47], "explicitli": [3, 17, 19, 22, 40, 46, 76, 91, 96, 98, 113, 143, 144], "gaussian": [3, 46, 70, 130, 131, 132, 156], "nuclei": [3, 4, 25, 31, 36, 39, 40, 47, 55, 144, 150], "interelectron": 3, "veri": [3, 4, 6, 8, 18, 20, 21, 33, 43, 45, 46, 47, 52, 53, 59, 60, 62, 69, 70, 72, 82, 89, 99, 101, 111, 113, 120, 122, 123, 128, 139, 141, 142, 143, 144, 149], "difficult": [3, 16, 46, 47, 55, 143], "coupl": [3, 15, 21, 27, 45, 46, 47, 49, 50, 55, 61, 67, 72, 78, 81, 88, 99, 102, 103, 106, 111, 117, 128, 141, 144, 149, 150], "explicit": [3, 4, 5, 10, 14, 20, 21, 29, 46, 49, 68, 70, 71, 73, 75, 83, 91, 103, 113, 120, 142, 143, 144, 148], "product": [3, 4, 11, 20, 25, 26, 28, 33, 61, 80, 82, 91, 92, 99, 100, 102, 136, 145], "sinc": [3, 5, 6, 11, 15, 17, 19, 20, 21, 25, 27, 34, 46, 49, 55, 61, 65, 66, 71, 72, 74, 76, 82, 83, 84, 90, 92, 97, 98, 101, 120, 122, 124, 133, 144, 153], "antisymmetr": [3, 80], "antisymmetris": 3, "version": [3, 14, 18, 42, 46, 55, 76, 89, 98, 142, 145, 148], "determin": [3, 4, 6, 7, 8, 10, 11, 12, 14, 15, 16, 18, 19, 20, 21, 22, 24, 27, 28, 33, 34, 35, 36, 38, 39, 40, 41, 43, 45, 46, 47, 49, 52, 55, 57, 60, 61, 65, 66, 67, 70, 72, 73, 75, 76, 80, 82, 83, 88, 89, 90, 91, 96, 98, 100, 101, 102, 105, 108, 111, 113, 120, 121, 122, 124, 128, 130, 132, 144, 149, 150, 153, 156], "sd": [3, 33, 71, 72], "result": [3, 4, 6, 7, 11, 12, 13, 15, 17, 18, 19, 20, 21, 22, 25, 26, 27, 28, 29, 31, 33, 34, 35, 36, 39, 41, 42, 43, 45, 46, 47, 52, 55, 59, 60, 62, 69, 71, 72, 74, 75, 76, 78, 82, 84, 86, 88, 90, 91, 92, 97, 98, 99, 100, 101, 102, 113, 115, 120, 122, 123, 124, 125, 126, 128, 133, 136, 137, 139, 142, 143, 144, 146, 147, 149, 153, 156, 157], "constitut": [3, 89, 130], "code": [3, 21, 33, 43, 46, 52, 59, 90, 91, 101, 105, 122, 147], "csf": 3, "fix": [3, 4, 20, 21, 25, 46, 47, 55, 62, 74, 82, 90, 92, 100, 108, 124], "linear": [3, 12, 14, 15, 20, 21, 28, 29, 31, 38, 43, 45, 46, 49, 61, 66, 67, 70, 72, 76, 78, 83, 84, 88, 91, 93, 96, 97, 98, 99, 102, 104, 111, 113, 117, 120, 124, 125, 129, 130, 131, 141, 143, 144, 148], "combin": [3, 6, 11, 15, 19, 21, 28, 31, 46, 47, 60, 61, 64, 66, 72, 78, 82, 88, 90, 91, 102, 140, 144, 149, 153], "attract": [3, 5, 8, 16, 21, 25, 39, 47, 69, 143, 144], "eigenfunct": [3, 15, 26, 31, 100, 122], "adapt": [3, 31, 38, 60, 69, 73, 97, 146], "less": [3, 7, 14, 18, 21, 66, 76, 83, 105, 108, 128, 149], "numer": [3, 5, 7, 14, 18, 22, 43, 48, 50, 52, 55, 61, 66, 67, 73, 82, 84, 89, 130, 132, 150], "than": [3, 4, 7, 11, 20, 21, 22, 25, 27, 30, 33, 39, 42, 43, 46, 47, 49, 52, 60, 61, 65, 72, 75, 80, 82, 84, 89, 90, 91, 96, 98, 101, 105, 108, 120, 122, 123, 124, 129, 139, 143, 144, 149, 153], "ha": [3, 5, 7, 8, 11, 13, 15, 19, 20, 21, 22, 25, 27, 29, 33, 38, 42, 43, 45, 46, 47, 50, 59, 60, 61, 64, 70, 71, 72, 74, 75, 76, 80, 82, 88, 89, 90, 92, 96, 98, 101, 102, 105, 106, 108, 111, 113, 115, 117, 120, 123, 124, 129, 136, 139, 142, 143, 144, 148, 149, 153], "standpoint": 3, "howev": [3, 6, 16, 17, 18, 20, 21, 24, 25, 33, 45, 46, 49, 55, 60, 61, 72, 75, 84, 89, 98, 99, 100, 101, 102, 103, 111, 117, 120, 122, 124, 128, 143, 144, 148, 149, 150], "allow": [3, 5, 16, 21, 22, 38, 41, 43, 45, 47, 52, 66, 68, 69, 70, 76, 82, 89, 91, 92, 99, 100, 102, 122, 141, 148, 149, 154], "outweigh": 3, "benefit": [3, 43], "slightli": [3, 21, 65, 111, 122, 149], "now": [3, 5, 10, 20, 21, 22, 25, 33, 42, 43, 45, 46, 47, 49, 52, 55, 60, 62, 65, 66, 70, 73, 75, 83, 90, 92, 100, 101, 106, 111, 113, 122, 125, 130, 131, 136, 139, 142, 144, 148, 153, 154, 156], "occup": [3, 7, 9, 20, 21, 24, 29, 33, 70, 75, 90, 101, 120, 122, 124, 125, 143, 145, 148, 150], "both": [3, 4, 8, 10, 17, 19, 20, 21, 24, 28, 29, 31, 33, 38, 43, 46, 47, 49, 55, 60, 69, 70, 72, 74, 75, 76, 78, 82, 84, 88, 90, 91, 92, 94, 111, 113, 120, 125, 130, 131, 132, 133, 136, 141, 143, 144, 148, 149, 152, 156], "match": [3, 20, 22, 33, 52, 101, 122, 129], "choic": [3, 10, 14, 18, 21, 27, 34, 38, 43, 47, 56, 58, 60, 78, 82, 84, 88, 128, 133], "lexic": 3, "revers": [3, 11, 17, 20, 21, 81, 91, 92, 94], "beyond": [3, 21, 33, 43, 53, 67, 143, 144, 149], "scope": [3, 21, 143, 149], "fortun": [3, 16, 71], "_2": [3, 4, 8, 11, 16, 20, 22, 25, 28, 30, 38, 66, 97, 120, 122, 123, 132, 136, 142, 143, 144, 146, 150, 153], "fock": [3, 4, 5, 6, 8, 13, 14, 19, 20, 21, 24, 25, 27, 28, 32, 34, 36, 38, 39, 41, 43, 46, 49, 50, 70, 71, 72, 76, 80, 88, 89, 92, 96, 97, 98, 100, 104, 105, 108, 111, 113, 120, 121, 122, 125, 136, 137, 143, 148, 150], "triplet": [3, 20, 31, 70, 122, 123, 136, 148], "unrestrict": [3, 9, 120, 121, 136, 137, 143, 144, 145, 148], "actual": [3, 20, 33, 43, 47, 49, 75, 90, 101, 122, 148], "could": [3, 20, 21, 43, 124, 143, 144, 147, 148], "singlet": [3, 20, 31, 70, 97, 122, 123, 124, 125, 142, 144, 145, 148, 153], "without": [3, 21, 27, 33, 42, 69, 73, 76, 82, 98, 101, 143, 144, 159], "np": [3, 4, 6, 7, 8, 10, 14, 17, 18, 20, 21, 22, 24, 25, 26, 27, 28, 29, 31, 33, 38, 39, 44, 47, 52, 58, 60, 62, 65, 70, 72, 75, 78, 81, 83, 86, 88, 92, 94, 96, 97, 99, 100, 101, 105, 106, 113, 115, 120, 124, 125, 130, 131, 132, 136, 139, 142, 143, 144, 145, 148, 151, 153, 156, 157], "o2_xyz": [3, 33], "600000000000": [3, 33], "000000000000": [3, 6, 7, 8, 10, 14, 17, 18, 21, 22, 33, 52, 72, 76, 83, 86, 89, 98], "set_multipl": [3, 20, 21, 24, 33, 120, 122, 136, 143, 144], "jupyt": [3, 4, 6, 7, 11, 13, 14, 18, 22, 24, 25, 26, 34, 36, 39, 41, 42, 43, 44, 47, 52, 58, 59, 62, 65, 70, 72, 75, 81, 88, 90, 92, 101, 102, 105, 113, 115, 124, 130, 131, 132, 133, 136, 137, 139, 140, 142, 143, 144, 151, 153, 154, 156, 157, 159], "scfunrestricteddriv": [3, 20, 21, 24, 33, 120, 122, 136, 143, 144], "fci": [3, 4, 8, 20, 21, 22, 33, 75, 101, 120], "Then": [3, 33, 65, 82, 124], "ciexpans": [3, 21, 33, 75], "necessari": [3, 47, 70, 72, 82, 89, 103, 124, 128, 132, 149], "handl": [3, 20, 45], "1200": [3, 47, 67, 156], "alreadi": [3, 21, 29, 43, 49, 61, 101, 131, 143, 148, 156], "fairli": [3, 101], "purpos": [3, 45, 46, 54, 70, 96, 143], "exclud": [3, 47, 133], "freez": [3, 126, 143], "n_frozen": [3, 33, 75], "120": [3, 60, 62, 67, 100, 132, 156], "themselv": [3, 4, 46, 47, 117], "easiest": [3, 133], "detlist": 3, "python": [3, 13, 18, 33, 42, 43, 67, 86, 94, 96, 154, 156], "impli": [3, 11, 16, 20, 29, 82, 88, 91, 92, 111, 117, 150], "predefin": [3, 74], "By": [3, 11, 20, 21, 22, 46, 49, 65, 70, 71, 73, 80, 91, 94, 122, 143, 144, 148], "directli": [3, 17, 21, 33, 34, 45, 72, 75, 82, 97, 113, 122, 139, 144, 148, 159], "represent": [3, 7, 11, 19, 37, 46, 65, 66, 67, 68, 69, 70, 73, 78, 88, 94, 99, 102, 115, 133, 148], "charact": [3, 19, 24, 26, 38, 43, 90, 102, 105, 148, 153], "doubli": [3, 4, 7, 10, 14, 21, 24, 25, 28, 33, 69, 72, 90, 97, 120, 122, 128, 143, 149], "list": [3, 4, 11, 24, 28, 29, 33, 42, 43, 52, 67, 72, 75, 81, 91, 101, 122, 124, 128, 140, 143, 144, 149], "det": [3, 19, 30, 33], "determinant_list": [3, 33], "occ_alpha": [3, 33], "occ_beta": [3, 33], "222aa0": [3, 24], "22a2a0": 3, "2a22a0": 3, "a222a0": 3, "22aa20": 3, "2a2a20": 3, "a22a20": 3, "2aa220": 3, "a2a220": 3, "aa2220": [3, 24], "22aaab": 3, "2a2aab": 3, "a22aab": 3, "2aa2ab": 3, "a2a2ab": 3, "aa22ab": 3, "2aaa2b": 3, "a2aa2b": 3, "aa2a2b": 3, "aaa22b": 3, "222a0a": 3, "22a20a": 3, "2a220a": 3, "a2220a": 3, "22aaba": 3, "2a2aba": 3, "a22aba": 3, "2aa2ba": 3, "a2a2ba": 3, "aa22ba": 3, "22aa02": 3, "2a2a02": 3, "a22a02": 3, "2aa202": 3, "a2a202": 3, "aa2202": 3, "2aaab2": 3, "a2aab2": 3, "aa2ab2": 3, "aaa2b2": 3, "2220aa": 3, "22abaa": 3, "2a2baa": 3, "a22baa": 3, "22a02a": 3, "2a202a": 3, "a2202a": 3, "2aab2a": 3, "a2ab2a": 3, "aa2b2a": 3, "22a0a2": 3, "2a20a2": 3, "a220a2": 3, "2aaba2": 3, "a2aba2": 3, "aa2ba2": 3, "2aa022": 3, "a2a022": 3, "aa2022": 3, "aaab22": 3, "22baaa": 3, "2202aa": 3, "2ab2aa": 3, "a2b2aa": 3, "220a2a": 3, "2aba2a": 3, "a2ba2a": 3, "2a022a": 3, "a2022a": 3, "aab22a": 3, "220aa2": 3, "2abaa2": 3, "a2baa2": 3, "2a02a2": 3, "a202a2": 3, "aab2a2": 3, "2a0a22": 3, "a20a22": 3, "aaba22": 3, "aa0222": 3, "2b2aaa": 3, "2ba2aa": 3, "2022aa": 3, "ab22aa": 3, "2baa2a": 3, "202a2a": 3, "ab2a2a": 3, "20a22a": 3, "aba22a": 3, "a0222a": 3, "2baaa2": 3, "202aa2": 3, "ab2aa2": 3, "20a2a2": 3, "aba2a2": 3, "a022a2": 3, "20aa22": 3, "abaa22": 3, "a02a22": 3, "a0a222": 3, "b22aaa": 3, "b2a2aa": 3, "ba22aa": 3, "0222aa": 3, "b2aa2a": 3, "ba2a2a": 3, "022a2a": 3, "baa22a": 3, "02a22a": 3, "0a222a": 3, "b2aaa2": 3, "ba2aa2": 3, "022aa2": 3, "baa2a2": 3, "02a2a2": 3, "0a22a2": 3, "baaa22": 3, "02aa22": 3, "0a2a22": 3, "0aa222": 3, "cioper": [3, 33, 75], "molecular": [3, 4, 5, 7, 8, 10, 11, 12, 14, 15, 16, 17, 19, 20, 21, 22, 24, 28, 29, 31, 33, 34, 35, 36, 38, 39, 40, 43, 45, 46, 47, 48, 52, 54, 55, 56, 57, 58, 59, 60, 61, 66, 67, 69, 70, 71, 74, 75, 76, 78, 80, 88, 89, 90, 96, 97, 98, 99, 100, 101, 102, 103, 105, 109, 111, 113, 117, 120, 121, 122, 124, 129, 130, 131, 132, 133, 140, 141, 142, 143, 144, 145, 148, 150, 152, 153, 156], "ci_ham": [3, 33], "compute_hint": [3, 33], "construct": [3, 8, 10, 18, 39, 43, 45, 46, 47, 49, 51, 53, 60, 62, 67, 69, 72, 73, 80, 101, 106, 113, 118, 124, 125, 128, 131, 133, 136, 139, 142, 143, 144, 145, 148, 149, 153, 157], "hij": [3, 33], "h_ci": 3, "zero": [3, 4, 7, 10, 14, 20, 21, 24, 27, 28, 29, 31, 33, 38, 39, 45, 46, 47, 52, 65, 70, 74, 75, 76, 81, 82, 83, 84, 86, 88, 97, 98, 99, 100, 102, 106, 111, 113, 115, 120, 124, 125, 130, 131, 132, 139, 143, 144, 145, 148, 151, 156, 157], "n_determin": [3, 21, 33], "idet": [3, 33], "jdet": 3, "w": [3, 7, 14, 21, 39, 67, 70, 78, 82, 89, 99, 100, 113, 124, 142, 144, 150, 153], "v": [3, 7, 14, 15, 16, 17, 18, 19, 21, 22, 25, 26, 27, 30, 31, 36, 39, 40, 52, 55, 65, 67, 75, 76, 78, 80, 88, 89, 91, 94, 99, 100, 108, 111, 113, 120, 125, 150], "147": [3, 156], "72339194": 3, "49488796": 3, "48991742": 3, "39178263": 3, "31022148": 3, "27297821": 3, "14365547": 3, "08916312": 3, "08242927": 3, "07852818": 3, "05836503": 3, "00699461": 3, "146": [3, 72, 125], "99905665": 3, "97927131": 3, "95353201": 3, "9354175": 3, "93382892": 3, "88967934": 3, "88480791": 3, "83509186": 3, "82598782": 3, "75346539": 3, "75077715": 3, "74829521": 3, "74125314": 3, "71397134": 3, "70255217": 3, "64273756": 3, "6366741": 3, "56810118": 3, "53923066": 3, "48989258": 3, "48113701": 3, "47615159": 3, "43900556": 3, "43155944": 3, "41314138": 3, "40393925": 3, "37524854": 3, "34672641": 3, "33446114": 3, "27975068": 3, "2749686": 3, "26378644": 3, "22065448": 3, "21747518": 3, "20946767": 3, "19236321": 3, "17110856": 3, "16624582": 3, "13162568": 3, "10690359": 3, "0604229": 3, "05944823": 3, "05247853": 3, "04847397": 3, "97547061": 3, "89703574": 3, "89485308": 3, "89424117": 3, "88770488": 3, "80696382": 3, "77118848": 3, "76968622": 3, "76657329": 3, "75603435": 3, "75598202": 3, "70968766": 3, "69813332": 3, "68735456": 3, "66670629": 3, "66467605": 3, "08963409": 3, "144": [3, 67, 115], "99400313": 3, "89601606": 3, "86160532": 3, "inde": [3, 21, 33, 65, 72, 74, 82, 111, 120, 122, 148], "higher": [3, 7, 8, 19, 26, 27, 35, 46, 47, 55, 67, 72, 74, 82, 84, 88, 89, 91, 92, 98, 101, 120, 122, 125, 129, 141, 143, 144, 149], "m_": [3, 16, 19, 20, 25, 31, 49, 66, 70, 72, 78, 82, 91, 120, 125, 143, 148, 150], "quintet": 3, "eigenvector": [3, 10, 45, 46, 52, 66, 70, 71, 72, 94, 113], "set_printopt": [3, 4, 10, 26, 27, 33, 38, 70, 72, 81, 97], "formatt": [3, 33], "float_kind": [3, 33], "969": [3, 144], "176": [3, 150], "049": 3, "003": [3, 24, 26, 70], "057": 3, "066": [3, 67], "036": [3, 26, 82, 150], "006": [3, 24], "007": [3, 20], "019": [3, 70, 153], "largest": [3, 11, 18, 20, 21, 52, 94, 96, 139, 142, 144], "curiou": 3, "happen": [3, 21, 52, 74, 90, 143, 153], "answer": [3, 20, 43, 92], "condon": [3, 33, 100], "rule": [3, 11, 25, 28, 46, 82, 91, 94, 100, 103, 105, 113], "term": [3, 6, 7, 8, 15, 16, 19, 20, 22, 24, 25, 26, 27, 31, 33, 39, 43, 44, 45, 46, 49, 52, 53, 55, 58, 59, 60, 61, 70, 71, 72, 73, 74, 78, 80, 82, 88, 89, 90, 91, 96, 97, 100, 111, 113, 141, 142, 143, 149], "formul": [3, 5, 12, 15, 19, 21, 43, 67, 73, 104, 144, 149, 153], "singli": [3, 21, 24, 33, 72, 75, 97, 122, 125, 143], "compar": [3, 4, 5, 15, 18, 19, 20, 21, 22, 27, 33, 34, 38, 41, 46, 49, 52, 56, 59, 60, 62, 70, 72, 73, 76, 83, 86, 88, 90, 92, 94, 96, 99, 106, 111, 113, 124, 126, 128, 129, 132, 136, 142, 143, 144, 146, 147, 148, 149, 151, 153], "easi": [3, 20, 21, 43, 45, 46, 47, 75, 105, 144], "deriv": [3, 4, 7, 19, 21, 22, 31, 33, 38, 45, 46, 48, 49, 50, 52, 55, 60, 61, 66, 67, 68, 73, 76, 80, 84, 86, 89, 90, 91, 98, 99, 100, 108, 111, 130, 132, 142, 150, 158], "standard": [3, 4, 8, 18, 19, 20, 21, 26, 43, 55, 71, 75, 89, 91, 99, 101, 108, 120, 141, 143, 144, 149, 150], "quantiz": [3, 9, 33, 72, 75], "reconcil": 3, "Being": 3, "those": [3, 6, 10, 18, 21, 25, 42, 43, 45, 46, 47, 48, 69, 72, 75, 80, 82, 90, 91, 92, 94, 105, 115, 124, 130, 143], "mo": [3, 4, 9, 10, 11, 13, 14, 15, 18, 21, 24, 25, 26, 28, 29, 33, 38, 39, 46, 49, 70, 71, 72, 75, 81, 86, 88, 94, 96, 97, 102, 105, 113, 120, 122, 125, 126, 137, 142, 143, 147, 148, 149, 150, 153, 157], "leav": [3, 11, 15, 25, 46, 63, 66, 91, 130, 132], "outsid": [3, 18, 20, 21, 34, 52, 90, 124], "inact": [3, 20, 21, 24, 33, 75, 90, 101, 111, 120, 124], "done": [3, 17, 20, 21, 42, 46, 47, 55, 70, 72, 73, 101, 106, 113, 117, 120, 125, 130, 133, 142, 143, 144, 148, 149, 150], "i_": [3, 61, 82], "h_": [3, 15, 21, 29, 33, 46, 49, 66, 72], "qi": [3, 46, 49], "ao": [3, 6, 7, 9, 18, 21, 24, 26, 28, 33, 38, 39, 46, 49, 61, 70, 75, 91, 113], "mu": [3, 6, 8, 15, 16, 33, 38, 39, 40, 46, 49, 61, 75, 76, 82, 83, 84, 86, 88, 89, 91, 98, 99, 100, 102, 111, 113, 117, 130, 144, 146, 150], "nu": [3, 15, 40, 46, 49, 66, 76, 89, 98], "lambda": [3, 14, 22, 25, 33, 36, 38, 45, 46, 49, 55, 61, 66, 82, 91, 94, 113, 117, 150], "sigma": [3, 10, 11, 21, 26, 33, 46, 47, 49, 71, 72, 76, 82, 83, 90, 91, 92, 98, 101, 102, 105, 120, 122, 124, 142, 144, 151], "repuls": [3, 4, 7, 8, 14, 15, 16, 20, 22, 25, 33, 35, 46, 47, 69, 70, 80, 120, 125, 143, 144, 148], "v_": [3, 7, 19, 39, 46, 47, 49, 80, 108], "nn": [3, 14, 46, 49], "nin": [3, 21], "n_inact": [3, 21], "nact": [3, 21], "n_activ": [3, 20, 21, 33, 120], "nba": [3, 21, 26], "n_orbit": 3, "v_nn": 3, "v_nuc": [3, 7, 14, 21, 39], "nuclear_repulsion_energi": [3, 7, 14, 21, 22, 25, 39], "kinetic_drv": [3, 7, 14, 17, 21, 39], "nucpot_drv": [3, 7, 14, 17, 21, 39], "nuclearpotentialintegralsdriv": [3, 7, 14, 17, 21, 22, 25, 39], "eri_drv": [3, 7, 14, 17, 21, 22, 25, 39], "electronrepulsionintegralsdriv": [3, 7, 14, 17, 21, 22, 39], "compute_in_memori": [3, 7, 14, 17, 21, 22, 25, 33, 39, 70, 86, 113], "alpha_to_numpi": [3, 21], "cact": [3, 21], "din": [3, 21], "mi": 3, "ni": 3, "mn": [3, 61, 70, 72, 86, 117, 159], "jin": [3, 21, 67], "mnl": 3, "coulomb": [3, 4, 7, 15, 19, 25, 33, 47, 49, 67, 73, 98, 143, 150], "kin": [3, 21], "mln": 3, "fin": [3, 21], "ein": [3, 21, 33], "transform": [3, 9, 10, 11, 15, 18, 21, 24, 28, 33, 43, 46, 66, 70, 71, 72, 75, 82, 84, 94, 97, 102, 130, 131, 132, 150, 153, 156], "ftu": [3, 21, 33], "qu": [3, 21, 46, 75], "pt": [3, 21, 46, 75], "tu": [3, 21, 75, 150], "pqrw": [3, 21], "pqr": [3, 17, 21, 22, 28, 29, 46, 70], "sw": [3, 21], "pqvw": [3, 21], "rv": [3, 21], "puvw": [3, 21], "tuvw": [3, 21, 33], "assert": [3, 73], "inen": [3, 33], "0e": [3, 7, 20, 65, 70, 72, 75, 76, 86, 89, 90, 98, 100, 101, 106, 120, 124, 125, 142, 143, 144, 148, 151, 153], "assert_almost_equ": [3, 33], "sc_diag": [3, 33], "occa": [3, 33, 143, 144], "occb": [3, 33, 143, 144], "inc": [3, 33], "sc_1exc": [3, 33], "ss_occ": [3, 33], "os_occ": [3, 33], "opposit": [3, 11, 20, 22, 28, 33, 47, 55, 60, 64, 96, 143], "sc_ss1exc": [3, 33], "sc_os1exc": [3, 33], "part": [3, 7, 8, 15, 19, 22, 27, 29, 33, 35, 38, 39, 43, 46, 47, 61, 70, 71, 72, 83, 90, 94, 97, 100, 101, 103, 104, 113, 124, 133, 142, 144, 149, 153, 156], "brought": [3, 55, 123], "maximum": [3, 8, 14, 20, 27, 33, 60, 65, 67, 86, 122], "concord": 3, "produc": [3, 47, 82, 92, 124], "switch": [3, 52, 74, 99, 101, 111], "until": [3, 14, 16, 19, 41, 60], "introduc": [3, 4, 9, 10, 14, 15, 16, 19, 22, 24, 25, 26, 27, 29, 36, 38, 46, 47, 53, 55, 56, 65, 69, 73, 74, 80, 82, 86, 88, 90, 91, 97, 100, 105, 122, 143, 144, 149], "phase": [3, 15, 29, 30, 33, 41, 46, 47, 67, 82, 88, 111, 113, 142, 144, 147], "conveni": [3, 4, 14, 15, 26, 29, 42, 46, 70, 88, 91, 97, 100, 124, 150], "achiev": [3, 5, 11, 14, 36, 43, 47, 60, 66, 67, 69, 101, 113, 141, 143, 144, 149, 153], "appli": [3, 11, 16, 19, 20, 21, 29, 33, 46, 47, 58, 60, 65, 66, 69, 70, 72, 74, 75, 76, 82, 83, 91, 96, 98, 99, 100, 101, 111, 117, 122, 125, 128, 144, 149], "twice": [3, 27, 31, 72], "keep": [3, 22, 69, 91, 101, 122, 136], "bring": [3, 21, 75, 101, 143, 144], "excite_alpha": [3, 33], "excite_beta": [3, 33], "associ": [3, 6, 9, 10, 11, 13, 15, 16, 18, 22, 24, 25, 26, 27, 29, 31, 35, 36, 38, 47, 78, 82, 86, 88, 91, 94, 99, 100, 102, 105, 111, 113, 117, 130, 132, 143, 150], "correct": [3, 8, 9, 19, 20, 21, 27, 43, 46, 47, 52, 55, 62, 65, 67, 70, 72, 80, 84, 89, 96, 111, 122, 128, 133, 143, 144, 149, 150], "With": [3, 4, 10, 12, 15, 20, 21, 25, 27, 30, 38, 45, 46, 47, 65, 74, 78, 88, 91, 99, 102, 105, 113, 122, 125, 128, 136, 137, 139, 143, 144, 149, 150, 151], "rewrit": [3, 46], "ham": [3, 67], "unocc_alpha": [3, 33], "excdet": [3, 33], "continu": [3, 33, 81, 96, 141, 148], "phase2": [3, 33], "exc2det": [3, 33], "unocc_beta": [3, 33], "structur": [3, 5, 8, 9, 13, 19, 21, 31, 33, 38, 39, 43, 44, 45, 46, 47, 48, 56, 58, 59, 60, 62, 64, 67, 68, 70, 74, 82, 88, 98, 100, 113, 120, 123, 124, 125, 126, 129, 131, 136, 140, 142, 144, 145, 146, 149, 150, 153, 157], "non": [3, 16, 19, 20, 21, 22, 25, 29, 33, 35, 45, 46, 52, 60, 70, 72, 73, 74, 76, 82, 84, 89, 90, 91, 98, 99, 108, 113, 117, 120, 123, 128, 130, 141, 142, 144, 145, 149], "723": 3, "495": 3, "seen": [3, 4, 6, 7, 14, 18, 21, 22, 27, 31, 39, 49, 55, 72, 74, 78, 82, 83, 84, 90, 92, 96, 105, 113, 122, 130, 139, 142, 143, 144, 148, 149], "n_": [3, 15, 17, 21, 66, 74, 86, 94, 113], "grow": 3, "extrem": [3, 55, 96, 143, 145, 148], "rapidli": [3, 19, 144], "even": [3, 20, 21, 27, 33, 39, 43, 49, 53, 74, 75, 82, 89, 90, 91, 98, 101, 108, 120, 121, 122, 144, 149], "faster": [3, 4], "exampl": [3, 5, 11, 12, 17, 18, 20, 24, 25, 26, 27, 31, 33, 38, 43, 45, 46, 47, 49, 52, 55, 60, 62, 65, 68, 69, 73, 74, 75, 76, 78, 88, 90, 91, 92, 96, 97, 98, 100, 102, 103, 105, 106, 111, 113, 120, 133, 136, 137, 139, 140, 143, 144, 147, 148, 150, 151], "210": [3, 156], "878": 3, "824": 3, "885": 3, "scale": [3, 17, 31, 36, 43, 47, 53, 55, 59, 67, 70, 71, 82, 90, 113, 123, 130, 131, 132, 133, 136, 137, 139, 143, 144, 154, 156, 159], "nearli": [3, 21], "tb": 3, "spars": 3, "storag": [3, 14, 71], "footprint": 3, "enorm": 3, "rare": [3, 100, 120], "ever": [3, 72], "entir": [3, 15, 21, 26, 70, 92, 130], "usual": [3, 20, 21, 33, 43, 46, 47, 50, 65, 66, 71, 74, 76, 82, 89, 98, 101, 120, 123, 143, 149], "focus": [3, 5, 43, 47, 82, 129, 141, 143, 144, 149, 152, 155], "progress": [3, 53], "effect": [3, 4, 9, 11, 14, 15, 19, 20, 21, 27, 33, 41, 46, 47, 67, 69, 72, 73, 74, 76, 82, 89, 96, 98, 124, 129, 141, 144, 148, 151], "boldsymbol": [3, 10, 11, 15, 17, 21, 33, 38, 39, 45, 46, 49, 52, 61, 70, 73, 75, 82, 91, 97, 111, 113, 132], "context": [3, 25, 43], "davidson": [3, 70, 75, 106, 113, 125, 141, 144], "trial": [3, 16, 76, 89, 90, 98, 124, 148], "accord": [3, 11, 14, 15, 17, 19, 21, 22, 24, 25, 27, 28, 29, 30, 38, 46, 55, 72, 82, 88, 91, 98, 99, 100, 111, 113, 126, 136, 142], "dav": 3, "h_0": [3, 22, 27], "r": [3, 4, 6, 7, 8, 11, 14, 15, 16, 17, 18, 19, 20, 21, 24, 25, 26, 27, 28, 29, 30, 31, 33, 36, 38, 39, 40, 45, 46, 47, 49, 55, 59, 62, 65, 66, 67, 70, 72, 73, 78, 81, 82, 84, 90, 91, 92, 94, 96, 97, 98, 99, 100, 102, 105, 108, 113, 120, 124, 125, 131, 132, 142, 143, 144, 150, 154, 156, 157], "precondition": 3, "residu": [3, 19, 33, 70, 72, 73, 75, 76, 78, 89, 90, 98, 99, 117, 124, 148], "improv": [3, 21, 27, 33, 41, 47, 55, 60, 62, 67, 72, 75, 94, 101, 128, 143, 145, 149], "small": [3, 4, 18, 19, 20, 21, 22, 25, 26, 35, 38, 42, 43, 46, 47, 49, 52, 53, 55, 60, 69, 72, 86, 89, 91, 92, 99, 101, 102, 111, 113, 115, 122, 126, 136, 142, 143, 144, 148], "sometim": [3, 21, 26, 43, 46, 69, 75, 120, 124, 150], "quantiti": [3, 6, 20, 30, 38, 46, 70, 73, 74, 82, 84, 89, 91, 98, 99, 111, 150], "equal": [3, 4, 7, 8, 10, 11, 14, 15, 16, 18, 19, 20, 22, 24, 25, 26, 27, 28, 29, 30, 31, 36, 38, 41, 46, 47, 55, 78, 82, 83, 86, 88, 89, 98, 100, 101, 102, 113, 120, 122, 124, 143, 144, 149, 150], "hundr": [3, 35, 53], "million": 3, "had": [3, 42, 49, 122], "trivial": [3, 15, 16, 25, 30, 46, 61, 83, 88, 101, 113, 148], "vec0": [3, 33], "random": [3, 27, 46, 55, 67, 82, 97, 111, 113], "rand": [3, 27, 97], "dot": [3, 6, 7, 14, 18, 60, 61, 82, 86, 91, 99, 106, 111, 113, 143, 148], "domin": [3, 7, 19, 72, 75, 86, 89, 105, 113, 120, 142, 143, 144, 153], "perform": [3, 6, 7, 8, 10, 11, 13, 14, 15, 18, 19, 20, 21, 22, 38, 39, 42, 43, 45, 46, 47, 51, 52, 56, 58, 60, 62, 64, 65, 67, 68, 72, 76, 82, 89, 92, 97, 98, 99, 102, 105, 113, 115, 120, 122, 124, 125, 128, 132, 133, 136, 137, 139, 142, 143, 144, 145, 148, 149, 150, 153, 156, 157], "hdiag": 3, "lowest_st": 3, "argmin": [3, 44], "initialis": [3, 21], "resnorm": 3, "istep": 3, "0001": [3, 20, 81, 90, 101, 105, 120, 124, 156], "norm": [3, 7, 14, 20, 21, 33, 36, 38, 39, 52, 60, 61, 70, 72, 75, 89, 90, 101, 120, 124, 125, 131, 143, 148], "sigvec0": 3, "recomput": 3, "scratch": [3, 43, 132], "prevent": [3, 29, 38, 120], "diverg": [3, 82], "vec1": [3, 33], "orthonorm": [3, 10, 15, 21, 27, 29, 30, 33, 49, 72, 97], "sigvec1": 3, "smallham": 3, "62953840021837": 3, "71940126561879": 3, "72318392969424": 3, "72336778079267": 3, "72338867249744": 3, "72339137919488": 3, "7233918396856": 3, "72339191989158": 3, "72339193438057": 3, "diagonalis": 3, "segment": [3, 153], "n_guess": 3, "definit": [3, 9, 20, 21, 46, 65, 75, 82, 84, 90, 91, 98, 99, 101, 120, 124], "virtual": [3, 4, 14, 17, 18, 20, 21, 22, 33, 46, 49, 70, 72, 75, 80, 86, 88, 90, 97, 98, 99, 101, 106, 111, 113, 120, 124, 126, 128, 142, 143, 144], "casscf": [3, 20, 21, 33, 75, 90, 92, 101, 120, 122, 124], "ca": [3, 17, 20, 21, 24, 33, 46, 75, 90, 101, 120, 122, 124, 159], "subspac": [3, 20, 29, 38, 70, 72, 75, 76, 89, 90, 98, 120, 125, 143, 148], "1e": [3, 7, 14, 17, 18, 20, 21, 24, 28, 33, 39, 41, 52, 60, 70, 72, 75, 81, 90, 101, 120, 124, 131], "08": [3, 7, 20, 67, 70, 72, 75, 76, 90, 98, 100, 101, 120, 124, 143], "squar": [3, 14, 34, 36, 41, 45, 47, 52, 61, 75, 89, 94, 100, 102, 153], "averag": [3, 8, 14, 20, 43, 52, 55, 67, 72, 74, 75, 76, 89, 90, 92, 93, 98, 120, 122, 124], "grad": [3, 20, 75, 90, 101, 120, 124], "time": [3, 7, 8, 11, 16, 17, 18, 19, 20, 22, 25, 26, 27, 29, 31, 38, 43, 46, 47, 49, 53, 61, 66, 67, 70, 72, 73, 74, 75, 76, 80, 82, 84, 86, 89, 90, 94, 96, 97, 98, 101, 103, 108, 109, 111, 113, 120, 122, 123, 124, 125, 133, 143, 144, 146, 148, 150, 151, 154, 156, 157], "629538400": 3, "6e": [3, 20, 75, 90, 101, 120, 124], "01": [3, 7, 8, 14, 20, 21, 22, 47, 60, 65, 70, 72, 75, 76, 81, 89, 90, 94, 98, 99, 100, 101, 113, 120, 124, 125, 142, 143, 144, 148, 151, 156], "719401373": 3, "02": [3, 4, 7, 14, 20, 21, 65, 67, 70, 72, 75, 76, 89, 90, 94, 98, 100, 101, 120, 122, 124, 143, 148, 156, 157], "03": [3, 7, 14, 20, 21, 65, 67, 70, 72, 75, 76, 89, 90, 94, 98, 100, 101, 120, 122, 124, 125, 143, 148, 156], "723346247": 3, "9e": [3, 20, 75, 90, 101, 120, 124], "05": [3, 4, 14, 18, 20, 21, 28, 33, 47, 52, 59, 67, 70, 72, 75, 76, 89, 90, 96, 98, 99, 100, 101, 113, 120, 122, 124, 125, 130, 131, 132, 133, 136, 137, 139, 143, 154, 156, 159], "723390649": 3, "06": [3, 7, 14, 20, 41, 47, 67, 70, 72, 75, 89, 90, 100, 101, 120, 122, 124, 125, 143, 148, 156], "723391935": 3, "3e": [3, 20, 65, 75, 90, 101, 120, 124], "7e": [3, 20, 75, 90, 101, 120, 124, 150], "09": [3, 20, 26, 65, 70, 72, 75, 90, 98, 100, 101, 120, 124, 125, 130, 143, 148], "723391938": 3, "8e": [3, 20, 75, 90, 101, 120, 124, 150], "72339193758123": 3, "95550": 3, "96583": 3, "04380": 3, "03557": 3, "cours": [3, 14, 20, 21, 36, 50, 101], "fulli": [3, 38, 39, 43, 46, 53, 96, 120, 143], "fewer": [3, 52, 90, 142], "despit": [3, 25, 46, 53, 143, 144, 149], "stricter": 3, "old": [3, 26, 46, 144], "intermedi": [3, 17, 20, 21, 27, 67, 68, 70, 73, 88, 144], "mcscf": [3, 20, 43, 46, 90, 93, 120, 123], "particl": [3, 6, 8, 9, 19, 21, 24, 25, 26, 31, 36, 38, 39, 46, 55, 61, 68, 70, 71, 72, 73, 94, 105, 108, 120, 122, 144, 148, 150, 153, 158], "d_": [3, 6, 15, 18, 21, 24, 28, 29, 33, 36, 46, 49, 61, 71, 91, 102, 105, 150, 153], "_p": [3, 25, 29, 33, 70, 72, 73, 75, 97], "_q": [3, 29, 33, 45, 52, 60, 70, 72, 73, 75, 82], "simplifi": [3, 21, 45, 46, 49, 69, 76, 91, 98, 125, 133], "delta_": [3, 15, 29, 38, 46, 49, 70, 72, 80, 84, 86, 91, 97, 100, 106, 113], "otherwis": [3, 46, 92, 132, 143], "exercis": [3, 46, 93, 98, 123, 141, 142], "try": [3, 10, 20, 42, 43, 55, 92, 101, 124, 128], "intuit": [3, 43, 101, 120], "origin": [3, 8, 11, 14, 17, 28, 31, 34, 38, 47, 62, 66, 73, 74, 84, 91, 94, 120, 141, 142, 143, 144], "born": [3, 47, 55, 100], "power": [3, 22, 43, 82, 89, 91, 102], "undeni": 3, "sort": [3, 19, 21, 70, 81], "across": [3, 43, 101], "offer": [3, 8, 18, 19, 36, 43, 60, 72, 96], "measur": [3, 4, 18, 55, 67, 74, 76, 84, 98, 141, 142, 143, 144, 151], "far": [3, 8, 21, 42, 43, 53, 72, 90, 91, 100, 101, 117, 120, 144], "reflect": [3, 11, 20, 63, 74, 122], "signific": [3, 20, 21, 27, 33, 53, 92, 96, 141, 142, 143, 144], "deviat": [3, 8, 47, 84, 120, 139, 143, 149, 150], "pictur": [3, 143, 144, 148], "chapter": [3, 21, 43, 53, 55, 67, 91, 101, 103, 120, 121, 123, 140, 147, 148, 158], "multiconfigur": [3, 23, 43, 67, 90, 93, 124], "dpq": [3, 33], "get_active_dens": [3, 4, 21, 33], "o2": [3, 33, 142], "flip": [3, 67, 128, 148, 149], "966": 3, "955": 3, "044": 3, "recogn": [3, 15, 16, 19, 35, 91], "earlier": [3, 5, 20], "come": [3, 5, 20, 21, 26, 47, 49, 55, 80, 82, 88, 96, 108, 142], "especi": [3, 47, 52, 143], "anti": [3, 11, 16, 29, 30, 33, 46, 72, 82, 129], "last": [3, 19, 27, 29, 33, 46, 65, 82, 91, 117, 120, 156], "benchmark": [3, 67, 128, 149], "fast": [3, 21, 43, 47, 52, 60, 67], "factori": 3, "polar": [3, 11, 20, 26, 39, 41, 61, 67, 68, 70, 72, 74, 76, 89, 91, 98, 99, 113, 117, 118, 126, 128, 143, 144, 149], "zeta": [3, 26, 49, 128, 149, 157], "903": 3, "316": [3, 67], "260": [3, 10], "expens": [3, 21, 60, 72, 128, 149], "obviou": [3, 21, 105], "cannot": [3, 11, 21, 45, 49, 71, 74, 76, 82, 89, 106, 124, 143, 144, 149], "taken": [3, 33, 46, 49, 55, 60, 61, 66, 71, 72, 74, 82, 89, 111, 124, 136, 142, 143, 144, 147, 148, 149], "turn": [3, 24, 25, 45, 61, 74, 82, 100, 105, 120, 125, 133, 136, 142, 143], "involv": [3, 6, 17, 21, 22, 28, 29, 34, 46, 47, 49, 61, 64, 69, 70, 71, 72, 74, 76, 80, 82, 84, 89, 90, 91, 94, 98, 100, 101, 102, 105, 113, 123, 124, 128, 129, 130, 132, 141, 142, 143, 149, 153], "after": [3, 10, 15, 19, 20, 21, 28, 38, 45, 46, 47, 49, 55, 60, 71, 82, 92, 101, 156], "h2o_xyz": [3, 6, 10, 14, 17, 18, 21, 22, 33, 39, 72, 83, 86, 132], "740848095288": [3, 6, 7, 10, 14, 17, 18, 21, 22, 72, 76, 83, 86, 89, 98], "582094932012": [3, 6, 7, 10, 14, 17, 18, 21, 22, 72, 76, 83, 86, 89, 98], "h2o": [3, 70, 72, 132], "h2o_orb": 3, "e_hf": [3, 20, 21, 33, 39, 120, 143], "cisd": [3, 21, 22, 75], "cisdt": [3, 75], "cisdtq": [3, 75], "fullci": [3, 20, 21, 101, 120], "e_fci": [3, 20, 21, 22, 120], "corr_perc": 3, "211": [3, 142, 144, 151], "plot": [3, 4, 8, 13, 14, 18, 20, 21, 27, 28, 31, 33, 47, 52, 58, 59, 60, 62, 65, 70, 75, 92, 94, 96, 100, 101, 102, 105, 106, 113, 120, 124, 126, 130, 131, 132, 137, 142, 143, 144, 146, 148, 151, 153, 156, 157], "212": [3, 142, 144, 151], "tight_layout": [3, 20, 21, 33, 47, 52, 62, 75, 92, 101, 106, 120, 124, 125, 130, 131, 132, 142, 143, 144, 148, 151, 156], "recov": [3, 22], "247e": 3, "11": [3, 7, 8, 14, 20, 21, 24, 31, 34, 36, 62, 65, 67, 70, 72, 75, 76, 81, 90, 91, 100, 101, 105, 113, 120, 122, 123, 124, 125, 142, 143, 144, 150, 156], "95": [3, 20, 21, 33, 52, 67, 72, 98, 100, 101, 120, 143, 156], "14": [3, 7, 13, 14, 18, 20, 21, 24, 27, 33, 39, 44, 62, 67, 72, 86, 89, 90, 101, 113, 120, 122, 123, 124, 125, 143, 144, 148, 156], "84": [3, 70, 120, 125, 143, 156], "99": [3, 7, 20, 24, 62, 67, 70, 120, 122, 143, 148, 156], "88": [3, 20, 70, 100, 120, 125, 143, 156], "low": [3, 20, 47, 55, 72, 98, 128, 130, 143, 144, 147, 148], "odd": [3, 72, 73, 91], "much": [3, 4, 5, 8, 18, 20, 25, 42, 43, 46, 49, 55, 82, 84, 98, 101, 120, 122, 123, 124, 143, 144], "rise": [3, 26, 46, 47, 82, 102, 103, 123], "remark": [3, 5, 20, 82], "count": [3, 18], "141": [3, 26, 67, 70, 100, 156], "828": 3, "clearli": [3, 4, 18, 20, 21, 27, 31, 47, 122, 142, 143], "scheme": [3, 6, 14, 16, 18, 19, 20, 22, 33, 34, 36, 38, 41, 46, 52, 53, 61, 67, 68, 70, 72, 76, 89, 98, 108, 118, 120, 122, 125, 128, 141, 142, 143, 144, 148, 149], "captur": [3, 4, 19, 21, 45, 73, 143, 149], "fraction": [3, 5, 19, 21, 46, 55], "dimer": [3, 8, 22, 67, 80, 94, 102, 105, 120, 153], "exactli": [3, 20, 43, 46, 122, 143], "monom": [3, 22, 80, 102, 105, 153], "\u00e5": [3, 8, 20, 21, 22, 33, 47, 52, 67, 72, 100, 102, 105, 120, 139], "dimer_xyz": [3, 8, 22, 94, 102, 105, 153], "e_2h2o": 3, "26": [3, 14, 20, 25, 26, 67, 75, 84, 90, 91, 100, 101, 113, 120, 122, 125, 143, 144, 156], "6f": [3, 34, 36, 38, 39, 41, 78, 83, 86, 89, 98, 113, 122], "152": [3, 125], "215193": 3, "224357": 3, "009163": 3, "systemat": [3, 67, 149], "failur": [3, 8, 153], "error": [3, 6, 10, 14, 18, 20, 21, 27, 34, 36, 39, 41, 46, 55, 67, 69, 70, 72, 90, 101, 120, 125, 141, 144, 148, 149], "whose": [3, 49, 91], "psi_a": [3, 15, 25, 99, 150], "ijab": [3, 21, 33, 46, 70, 72], "klcd": [3, 46, 72], "psi_b": [3, 25, 86, 99, 150], "kl": [3, 7, 10, 14, 21, 39, 46, 49, 71, 72], "cd": [3, 17, 38, 42, 46, 72, 102], "apart": [3, 8, 15, 22, 43, 70, 72], "ones": [3, 7, 14, 18, 21, 33, 45, 46, 49, 72, 139, 144], "begin": [3, 6, 8, 11, 14, 15, 16, 17, 19, 20, 22, 24, 25, 26, 27, 28, 29, 30, 31, 33, 36, 38, 45, 46, 47, 49, 55, 60, 71, 76, 82, 83, 84, 86, 88, 89, 91, 94, 97, 98, 99, 101, 102, 106, 111, 113, 117, 122], "align": [3, 6, 8, 15, 17, 20, 22, 24, 25, 27, 28, 29, 31, 33, 47, 49, 55, 60, 74, 82, 83, 86, 88, 96, 97, 102, 106, 113, 122, 144], "big": [3, 7, 14, 15, 16, 17, 18, 19, 21, 22, 24, 25, 27, 28, 29, 30, 31, 33, 36, 38, 41, 46, 49, 52, 66, 72, 76, 82, 86, 88, 94, 97, 98, 113, 117], "c_0": [3, 27], "_0": [3, 16, 22, 27, 38, 66, 76, 78, 84, 86, 88, 89, 91, 98, 99, 111, 123], "qquad": [3, 6, 7, 16, 22, 25, 27, 29, 31, 36, 38, 39, 86, 88, 97, 99, 113, 150], "quadrupl": [3, 149], "subsystem": [3, 27, 42], "exist": [3, 7, 10, 16, 21, 29, 31, 33, 35, 43, 73, 74, 76, 82, 101, 108], "partial": [3, 7, 19, 21, 35, 36, 38, 39, 41, 45, 46, 47, 49, 52, 55, 83, 84, 86, 91, 96, 100, 108, 111, 130, 143, 144], "quadrupli": 3, "estim": [3, 46, 47, 65, 89, 98, 122, 134, 136, 143, 144, 145, 149], "perturb": [3, 9, 17, 21, 32, 33, 43, 46, 50, 61, 67, 68, 70, 72, 73, 76, 82, 89, 91, 98, 99, 111, 113, 143, 150], "delta": [3, 7, 8, 15, 16, 17, 19, 24, 28, 29, 33, 38, 45, 46, 47, 52, 55, 60, 65, 70, 71, 72, 74, 76, 82, 83, 86, 91, 99, 100, 105, 117, 143, 146, 148, 149, 153], "rm": [3, 74, 76, 89, 91, 98, 117, 150], "vec": [3, 33, 75, 81, 90, 91, 122, 124], "coef": [3, 24, 122], "22222222220000000000000000": 3, "965": 3, "932": 3, "2222200000000": 3, "981": [3, 101], "962": 3, "e_d_2h2o": 3, "e_d_h2o": 3, "232092": 3, "234148": 3, "002056": 3, "been": [3, 5, 7, 15, 19, 20, 21, 22, 27, 43, 46, 47, 52, 59, 61, 66, 82, 88, 89, 92, 98, 102, 103, 105, 106, 108, 113, 117, 143, 144, 148, 149, 153], "notic": [3, 29, 33, 82, 124, 143, 144], "reduc": [3, 9, 16, 20, 21, 26, 30, 38, 69, 70, 72, 73, 76, 82, 89, 97, 98, 100, 101, 106, 111, 113, 120, 125, 143, 148, 150, 156], "disappear": 3, "landscap": 3, "accur": [3, 4, 5, 12, 19, 21, 25, 43, 46, 47, 51, 67, 69, 75, 76, 83, 89, 96, 100, 101], "supplant": 3, "stem": [4, 7, 46, 82], "instantan": [4, 8], "manifest": 4, "relationship": [4, 29, 66, 91, 150], "neq": [4, 15, 38, 61, 72, 80, 98, 113], "incorrectli": [4, 21], "independ": [4, 8, 16, 22, 25, 26, 27, 31, 38, 45, 46, 49, 61, 69, 76, 84, 89, 97, 98, 99, 100, 111, 144, 150], "motion": [4, 25, 31, 66, 67, 120, 131], "aris": [4, 8, 21, 46, 74, 82, 88, 89, 101, 141, 143, 144], "primari": [4, 16], "sourc": [4, 8, 42, 43, 82, 99, 111, 117, 149], "fermion": [4, 30], "natur": [4, 9, 20, 21, 22, 27, 33, 38, 43, 67, 70, 71, 74, 75, 80, 82, 89, 90, 91, 99, 101, 102, 105, 117, 120, 122, 124, 125, 128, 141, 143, 144, 145, 149, 150, 158], "perspect": [4, 18], "discrep": [4, 22, 62, 96, 143, 144], "textrm": [4, 106, 108, 111, 113, 136, 143, 149, 151], "corr": 4, "plethora": [4, 149], "model": [4, 5, 19, 20, 27, 35, 39, 41, 43, 46, 47, 53, 54, 67, 69, 70, 92, 100, 103, 120, 125, 140, 141, 143, 144, 145, 148, 149, 159], "l\u00f6wdin": [4, 38, 67, 120], "low80": [4, 67], "wf": 4, "studi": [4, 5, 16, 18, 19, 24, 27, 31, 39, 43, 47, 67, 76, 78, 82, 89, 92, 94, 96, 102, 103, 105, 115, 117, 122, 123, 125, 142, 143, 148, 149, 153], "precis": [4, 6, 10, 21, 26, 27, 38, 46, 70, 72, 75, 81, 97, 144], "suppress": [4, 10, 26, 27, 38, 70, 72, 81, 88, 97, 131], "linewidth": [4, 10, 26, 27, 38, 97, 99, 113, 142, 157], "170": [4, 26, 62, 97, 100], "mol_str": [4, 7, 20, 21, 24, 25, 26, 28, 33, 38, 52, 75, 76, 89, 90, 98, 100, 101, 120, 122, 143, 157], "000000": [4, 20, 33, 34, 36, 41, 70, 72, 81, 89, 90, 101, 120, 122, 124, 131, 142, 143, 148], "70": [4, 20, 62, 100, 101, 120, 143, 156], "unit": [4, 8, 20, 21, 28, 31, 33, 38, 39, 47, 52, 61, 67, 70, 76, 82, 84, 91, 92, 98, 100, 120, 122, 124, 131, 144], "au": [4, 28, 38, 65, 72, 76, 84, 90, 91, 98, 113, 124, 125, 130, 131, 132, 142, 143, 144, 145, 151, 153, 156], "pvdz": [4, 6, 7, 10, 13, 14, 17, 18, 20, 22, 24, 25, 26, 28, 33, 39, 78, 92, 120, 122, 143, 149, 157], "norb": [4, 7, 10, 14, 18, 20, 24, 28, 38, 70, 86, 88, 94, 96, 113, 115, 120], "hf_energi": 4, "ci_energi": 4, "ci": [4, 20, 21, 33, 44, 49, 70, 72, 80, 90, 93, 101, 115, 118, 120, 124, 126, 143], "12870945": 4, "16339873": 4, "03468928": 4, "investig": [4, 5, 19, 27, 96, 126, 136, 143, 144], "visualizationdriv": [4, 20, 28, 70, 120, 143, 157], "orbit": [4, 6, 7, 9, 10, 11, 12, 14, 15, 17, 18, 19, 20, 21, 22, 28, 29, 31, 33, 39, 43, 46, 49, 67, 69, 70, 71, 72, 75, 80, 86, 88, 89, 90, 92, 96, 101, 102, 105, 106, 108, 111, 113, 115, 120, 121, 122, 124, 126, 141, 142, 144, 145, 148, 149, 152, 158], "vis_drv": [4, 20, 28, 70, 120, 143, 157], "get_orbital_valu": [4, 120], "coord": [4, 20, 28, 38, 52, 67, 120, 130, 131, 132, 143, 156, 157], "orbital_valu": [4, 20, 120], "get_mo": [4, 20, 120, 143, 157], "get_n1": 4, "hf_onepart_denmat": 4, "fci_onepart_denmat": 4, "n1_hf": 4, "n1_fci": 4, "endpoint": [4, 20], "axvlin": [4, 8, 120], "setp": [4, 27, 28, 31, 96, 105, 157], "gca": [4, 27, 28, 96, 105, 157], "internuclear": [4, 8, 28, 100, 120], "minor": 4, "upon": [4, 21, 82, 91], "inspect": [4, 21], "discern": 4, "middl": [4, 20, 47, 120], "compens": 4, "shortcom": [4, 101], "reveal": [4, 105, 123], "get_n12": [4, 120], "orbital_values_1": [4, 120], "orbital_values_2": [4, 120], "hf_twopart_denmat": [4, 120], "ci_twopart_denmat": [4, 120], "get_active_2body_dens": [4, 20, 21, 120], "n12_hf": [4, 120], "n12_fci": [4, 120], "probabl": [4, 20, 28, 30, 55, 69, 92, 144], "nucleu": [4, 28, 55, 61, 120, 157], "orbital_values_at_h1": [4, 120], "shown": [4, 15, 16, 27, 38, 46, 47, 49, 55, 60, 69, 72, 98, 117, 124, 141, 142, 144, 149], "asymmetri": [4, 8, 74], "correctli": [4, 52, 98], "discontinu": 4, "likewis": 4, "relat": [4, 10, 15, 16, 17, 21, 22, 24, 28, 29, 30, 31, 33, 38, 42, 43, 45, 48, 49, 52, 56, 60, 61, 65, 66, 67, 68, 70, 73, 74, 75, 76, 82, 84, 88, 89, 91, 98, 100, 103, 113, 117, 130, 132, 143, 148, 153], "inter": 4, "displai": [4, 28, 43, 120, 133], "slow": [4, 60], "coincid": [4, 82, 84], "theta": [4, 8, 31, 46, 47, 82, 84, 91, 100], "co": [4, 8, 19, 28, 31, 47, 67, 82, 133, 136, 139, 144], "sin": [4, 8, 31, 82, 88, 99, 100, 111], "n12_fci_l": 4, "180": [4, 8, 44, 47, 62], "190": [4, 100, 156], "60": [4, 7, 20, 47, 62, 89, 90, 92, 100, 101, 120, 124, 125, 143, 156], "therefor": [4, 15, 18, 20, 24, 38, 46, 64, 65, 71, 72, 74, 80, 82, 89, 91, 96, 97, 101, 102, 113, 115, 150], "qualiti": [4, 6, 18, 34, 36, 41, 78, 89, 136], "sharper": 4, "why": [4, 20, 21, 22, 90, 92, 120, 131], "dft": [4, 5, 6, 7, 8, 16, 18, 19, 21, 23, 43, 67, 76, 81, 89, 90, 98, 100, 102, 122, 128, 139, 141, 142, 149], "contrast": [4, 16, 20, 22, 34, 49, 98, 120, 143, 147], "accommod": [4, 31, 38, 143], "descript": [4, 5, 19, 23, 27, 32, 39, 43, 47, 67, 72, 90, 94, 101, 121, 122, 125, 128, 143, 149, 153], "incept": 5, "1964": [5, 16, 67, 156], "hk64": [5, 16, 67], "obscur": [5, 43], "physic": [5, 11, 19, 20, 33, 38, 47, 53, 67, 72, 82, 91, 94, 113, 120, 122, 129, 140, 143, 144, 150], "approach": [5, 8, 15, 17, 20, 21, 22, 35, 43, 46, 47, 52, 55, 60, 64, 67, 68, 71, 72, 78, 80, 82, 99, 100, 106, 109, 111, 115, 117, 122, 123, 124, 141, 142, 143, 145, 148, 149], "solid": [5, 19, 67, 76, 82], "applic": [5, 9, 14, 16, 19, 53, 67, 88, 93, 99, 101, 113, 118, 141], "develop": [5, 19, 20, 43, 53, 54, 67, 91, 98, 103, 106, 143, 144, 153], "foundat": [5, 16, 82, 104, 129, 143], "establish": [5, 128, 149], "nevertheless": [5, 19, 91, 142, 143, 144, 149], "remain": [5, 15, 16, 18, 21, 43, 53, 55, 60, 66, 69, 91, 122, 143, 148, 149], "evolv": [5, 159], "research": [5, 43, 53], "area": [5, 142, 150, 151], "unresolv": 5, "question": [5, 43, 60, 143], "symmetri": [5, 19, 20, 29, 31, 41, 46, 47, 56, 65, 67, 74, 76, 82, 84, 91, 102, 143], "dilemma": 5, "gorling93": [5, 67], "novel": [5, 43], "cmsy12": [5, 67], "attempt": [5, 16, 19, 20, 42, 92, 144, 149], "were": [5, 16, 19, 20, 21, 43, 65, 72, 82, 90, 101, 105, 113, 120, 153], "rather": [5, 18, 20, 21, 41, 46, 49, 60, 70, 76, 90, 98, 122, 143, 144, 148, 149], "disappoint": [5, 21, 101], "poor": [5, 14, 19, 21, 62, 144, 149], "success": [5, 27, 36, 50, 61, 66, 149], "late": [5, 19], "1980": [5, 19, 67], "immedi": [5, 11, 46, 72, 82, 102, 133], "attent": [5, 19, 91], "breakthrough": 5, "becam": [5, 19], "mainli": [5, 74, 124, 129, 143, 144], "capabl": [5, 7, 19, 43, 53, 128, 144, 149], "later": [5, 10, 21, 33, 70, 83, 142], "rapid": [5, 43], "popular": [5, 19, 21], "situat": [5, 15, 19, 21, 25, 33, 34, 73, 82, 96, 101, 120, 122, 128, 144, 149], "wide": [5, 12, 19, 43, 74, 91, 101, 109, 122], "wa": [5, 16, 19, 21, 35, 42, 47, 49, 53, 55, 70, 72, 73, 82, 90, 99, 101, 113, 122], "inher": [5, 19], "via": [5, 19, 43, 46, 68, 73], "inexpens": [5, 38], "featur": [5, 27, 69, 124, 125, 126, 133, 139, 141, 142, 143, 144, 146, 148, 149, 151, 158], "accuraci": [5, 6, 7, 12, 18, 19, 27, 46, 47, 52, 67, 91, 96, 101, 136, 143, 144], "sophist": [5, 149], "inito": 5, "hohenberg": [5, 67], "theorem": [5, 20, 21, 46, 75, 84, 111, 143, 146], "resembl": [5, 7, 61], "scf": [5, 6, 10, 18, 20, 21, 25, 33, 38, 40, 43, 46, 47, 49, 52, 59, 61, 67, 70, 72, 83, 100, 102, 108, 113, 115, 120, 122, 124, 125, 132, 136, 139, 142, 143, 145, 146, 148, 149, 151, 153, 157], "ast": [6, 7, 24, 25, 28, 88, 97, 106, 111, 113, 117, 142, 146, 150], "d_alpha": [6, 13, 18, 24, 28, 33, 38, 39, 83], "d_beta": [6, 13, 18, 24, 28, 33, 83], "observ": [6, 15, 20, 65, 72, 74, 78, 82, 86, 89, 91, 96, 111, 113, 142, 143, 144, 148, 154], "scalar": [6, 25, 28, 76, 82, 89, 91, 94, 141, 144, 149], "omega": [6, 8, 11, 17, 25, 27, 28, 29, 38, 46, 47, 49, 61, 70, 71, 72, 73, 75, 76, 78, 82, 83, 84, 88, 89, 91, 94, 98, 99, 102, 106, 111, 113, 117, 130, 150, 151], "_i": [6, 14, 16, 18, 21, 25, 28, 29, 36, 40, 55, 60, 66, 70, 72, 82, 86, 88, 90, 91, 94, 97, 111], "perman": [6, 11, 40, 46, 67, 74, 82, 83, 84, 98, 111], "dipol": [6, 8, 11, 20, 40, 41, 43, 46, 47, 48, 49, 61, 66, 67, 70, 74, 75, 86, 88, 90, 91, 99, 100, 101, 102, 106, 111, 117, 120, 123, 124, 125, 130, 131, 141, 144, 148, 150], "moment": [6, 11, 20, 35, 41, 43, 46, 47, 48, 49, 61, 66, 67, 70, 72, 74, 75, 78, 82, 88, 90, 91, 94, 98, 99, 100, 101, 102, 111, 113, 117, 120, 123, 124, 125, 130, 131, 142, 144, 148, 150, 151], "_z": [6, 26, 31, 33, 82, 86], "evalu": [6, 8, 19, 28, 29, 36, 38, 46, 47, 55, 62, 67, 86, 103, 144], "techniqu": [6, 9, 15, 21, 43, 46, 48, 52, 60, 69, 83, 101, 113, 122, 133, 141, 144], "approx": [6, 7, 18, 25, 33, 46, 49, 60, 82, 98, 130], "w_g": [6, 7], "_g": [6, 7, 18, 122], "grid_level": [6, 7, 18, 65, 100, 144], "dftutil": [6, 18], "get_default_grid_level": [6, 18], "grid_drv": [6, 7, 18], "veloxchemlib": [6, 7, 18, 60, 70, 130, 131, 132, 156], "griddriv": [6, 7, 18], "set_level": [6, 7, 18], "molgrid": [6, 7, 18], "w_to_numpi": [6, 7, 18], "z_g": 6, "z_to_numpi": [6, 17, 18, 38, 39, 70, 75, 83, 86, 144], "xc_drv": [6, 7, 18], "xcintegr": [6, 7, 18], "chi_g": [6, 7, 18], "compute_gto_valu": [6, 7, 18], "bg": [6, 7, 18], "ag": [6, 7, 18], "n_g": [6, 18], "44687595": 6, "think": [6, 33, 131, 146, 149], "dipole_drv": [6, 17, 38, 39, 70, 75, 83, 86, 88, 113, 144], "electricdipoleintegralsdriv": [6, 17, 38, 39, 70, 75, 83, 86, 88, 113, 144], "dipole_mat": [6, 17, 38, 39, 70, 75, 83, 86, 88], "mu_z": [6, 17, 33, 39, 61, 76, 82, 83, 86, 89, 102, 105, 113], "44687507": 6, "agreement": [6, 10, 14, 22, 39, 47, 78, 86, 88, 89, 94, 115, 122, 124, 143, 144, 149], "counterpart": [7, 14], "contraint": 7, "eigenfuct": 7, "_j": [7, 14, 15, 16, 21, 25, 28, 55, 66, 72], "least": [7, 11, 20, 25, 49, 69, 72, 128, 141, 143, 149], "potenti": [7, 8, 16, 19, 20, 21, 34, 36, 39, 40, 41, 45, 46, 47, 49, 50, 51, 55, 56, 57, 58, 60, 64, 67, 68, 69, 70, 84, 91, 108, 120, 123, 125, 134, 141, 143, 144, 148, 149, 150], "pure": [7, 8, 25, 33, 39, 43, 82, 89, 90, 113, 120, 128, 149], "wherea": [7, 8, 11, 15, 27, 31, 46, 72, 74, 76, 82, 84, 91, 96, 105, 122], "hybrid": [7, 35, 43, 46, 49, 60, 67, 113], "made": [7, 16, 17, 27, 34, 38, 43, 46, 47, 49, 67, 76, 86, 88, 90, 91, 96, 148, 150], "accordingli": [7, 46, 143], "just": [7, 20, 47, 55, 65, 70, 75, 84, 89, 91, 100, 113, 124, 133, 142, 143, 147, 149], "assumpt": [7, 14, 21], "mere": [7, 14, 25, 136, 149], "varepsilon_": [7, 15, 18, 19, 22, 31, 33, 49, 70, 72, 91], "lda": [7, 46], "phi_i": [7, 11, 28, 30, 46, 72, 94, 108, 144], "number_of_electron": [7, 13, 33], "34363816": 7, "conv_thresh": [7, 14, 21, 33, 39, 60, 65, 70, 72, 100, 106, 124, 131, 142, 144, 148, 151, 153], "7f": [7, 47, 130, 131, 132, 156], "1874344": 7, "overlap_drv": [7, 14, 17, 39], "overlapintegralsdriv": [7, 14, 17, 39], "hamiltonian": [7, 11, 14, 15, 16, 21, 22, 26, 27, 31, 35, 39, 46, 68, 70, 72, 73, 75, 78, 80, 82, 83, 88, 96, 99, 100, 111, 143, 149], "c1dii": [7, 14], "f_mat": [7, 14], "e_vec": [7, 14, 21, 39], "build": [7, 14, 17, 42, 43, 70, 71, 72, 76, 89, 91, 98, 140, 143, 144, 145, 147, 148], "inv": [7, 14, 38, 60, 86, 106, 113, 148], "f_dii": [7, 14], "contrbut": 7, "lda_exchang": 7, "e_xc": 7, "v_xc": 7, "f_xc": 7, "max_it": [7, 14, 21, 33, 39, 60, 100], "50": [7, 8, 14, 20, 27, 28, 38, 39, 41, 60, 62, 70, 72, 75, 81, 83, 90, 100, 101, 105, 113, 120, 122, 124, 125, 130, 131, 132, 143, 144, 148, 156], "core": [7, 14, 18, 22, 25, 43, 46, 67, 68, 72, 86, 104, 126, 141, 142, 144, 145, 146, 149], "ik": [7, 10, 14, 21, 39, 46, 66, 72, 82], "jk": [7, 14, 21, 33, 39, 46, 49, 72], "ijkl": [7, 14, 21, 39, 46], "comparison": [7, 10, 20, 33, 60, 67, 68, 70, 89, 96, 143, 144, 146, 149], "ilkj": [7, 14, 21, 39], "e_exact_exchang": 7, "metric": [7, 14, 39, 113], "e_mat": [7, 14], "multi_dot": [7, 14, 33, 52, 70], "reshap": [7, 14, 21, 33, 38, 39, 52, 70, 94, 130, 131, 132, 156], "67": [7, 67, 76, 101, 120, 122, 124, 125, 143, 144, 148, 156], "80508830": 7, "89381306": 7, "93847705": 7, "14e": [7, 21, 89], "66": [7, 20, 89, 101, 120, 122, 143, 148, 156], "26792219": 7, "28078058": 7, "13537283": 7, "19e": [7, 72, 76], "99359878": 7, "76615742": 7, "60690061": 7, "13e": 7, "12110246": 7, "90554682": 7, "73394901": 7, "65e": 7, "13715465": 7, "92293008": 7, "75103380": 7, "94e": [7, 72], "16585462": 7, "99147909": 7, "82023741": 7, "22e": [7, 72], "18739992": 7, "11598421": 7, "94844153": 7, "24e": 7, "18742612": 7, "11619778": 7, "94863105": 7, "35e": [7, 14, 72], "18743428": 7, "11849075": 7, "95101979": 7, "61e": [7, 72, 76], "18743440": 7, "11879444": 7, "95133716": 7, "63e": [7, 72], "11879427": 7, "95133701": 7, "68e": [7, 72, 98], "83": [7, 20, 70, 72, 89, 120, 125, 143, 156], "harte": 7, "phi_j": [7, 72, 86], "cancel": [7, 15, 19, 29, 46, 55, 101, 143, 149], "classic": [7, 19, 36, 37, 39, 55, 61, 68, 72, 76, 91, 100, 150], "longer": [7, 21, 33, 46, 47, 49, 103, 122, 143], "guarante": [7, 14, 60, 120], "varepsilon": [7, 10, 15], "f_xc_ii": 7, "k_ii": 7, "g_iiii": 7, "abcd": [7, 17, 22, 25, 150], "lda_x_ii": 7, "hf_x_ii": 7, "scatter": [7, 14, 18, 60, 61, 67, 88, 89, 91, 94, 103, 113, 129, 132, 141], "fontsiz": [7, 105, 143], "sie": [7, 143, 144], "percentag": [7, 126], "exce": [7, 60], "97": [7, 41, 44, 67, 70, 101, 124, 125, 143, 148, 156], "1f": [7, 47, 81, 136, 150], "62": [7, 20, 28, 90, 100, 101, 120, 122, 124, 131, 143, 156], "73": [7, 14, 20, 39, 67, 90, 101, 120, 125, 143, 144, 156], "outer": [7, 20, 47, 143, 144, 149], "valenc": [7, 26, 45, 67, 68, 72, 90, 104, 123, 126, 141, 149, 151, 153], "substanti": [7, 39, 47, 62, 141, 145, 149, 157], "inner": [7, 143, 149], "86": [7, 20, 101, 120, 131, 143, 156], "87": [7, 20, 62, 70, 89, 90, 101, 120, 124, 143, 156], "98": [7, 67, 70, 76, 89, 98, 100, 120, 122, 125, 148, 156], "neutral": [8, 84, 143, 144, 145], "nonpolar": 8, "suffici": [8, 16, 42, 47, 76, 98, 111, 117, 124, 143, 148, 149], "known": [8, 15, 22, 25, 26, 27, 29, 30, 36, 45, 46, 55, 74, 76, 78, 82, 88, 89, 91, 98, 99, 100, 108, 111, 122, 144], "van": [8, 18, 19, 34, 36, 67], "der": [8, 18, 19, 34, 36], "waal": [8, 18, 19, 34, 36], "prototyp": [8, 43, 144], "exemplifi": [8, 11, 45, 47], "2e_": 8, "interatom": [8, 38, 47, 153], "mp2": [8, 21, 43, 49, 67, 72, 139, 143, 144, 145, 146, 148], "au2ang": [8, 18], "529177": [8, 120], "atom_xyz": 8, "dimer_separ": 8, "atom_basi": 8, "aug": [8, 18, 26, 78, 128, 144, 149], "dimer_basi": 8, "hf_atom_energi": 8, "mp2_atom_energi": 8, "hf_dimer_energi": 8, "mp2_dimer_energi": 8, "dist": [8, 20, 21, 52, 120, 153], "micro": 8, "hf_interaction_energi": 8, "mp2_interaction_energi": 8, "1000": [8, 47, 60, 76, 98, 100, 130, 143, 150, 156], "1e6": 8, "interpol": [8, 47, 58, 67, 113, 124, 144], "e_h": [8, 150], "minimum": [8, 45, 46, 50, 57, 60, 92, 122, 133], "lack": [8, 19, 20, 21, 22, 89, 90, 143, 144, 149], "r_0": [8, 47, 100], "inset": 8, "below": [8, 11, 18, 21, 30, 33, 42, 45, 47, 60, 62, 69, 70, 72, 73, 82, 89, 91, 94, 101, 102, 105, 108, 122, 124, 131, 133, 141, 142, 143, 144, 146, 148, 157], "concern": [8, 11, 25, 56, 67, 72, 88, 91, 96, 136, 141, 148, 149], "_1": [8, 11, 15, 16, 22, 25, 28, 30, 38, 66, 97, 123, 150], "circ": [8, 47, 74], "fluctuat": 8, "induc": [8, 40, 46, 47, 67, 74, 76, 82, 88, 91, 99, 102], "weakli": [8, 19, 105], "randomli": [8, 61, 67, 74, 82], "orient": [8, 61, 67, 74, 76, 89, 100, 133, 142], "casimir": 8, "polder": 8, "eqnarrai": [8, 17, 29, 76, 82, 89, 91, 98, 99, 117], "hbar": [8, 16, 19, 25, 31, 38, 61, 70, 73, 75, 78, 82, 99, 100, 111, 117, 122, 150], "int_": [8, 82, 151], "infti": [8, 16, 22, 27, 55, 89, 91, 151], "_a": [8, 21, 25, 27, 36, 38, 39, 52, 72, 86, 88, 90, 97], "_b": [8, 21, 25, 27, 38, 72, 86], "nonumb": [8, 46, 60, 72, 91], "quad": [8, 11, 14, 15, 16, 22, 26, 27, 31, 46, 70, 72, 94, 113], "intermolecular": [8, 67, 91, 105, 153], "speed": [8, 46, 55, 66, 82, 91, 150], "isotrop": [8, 20, 74, 75, 84, 117, 142, 144], "electr": [8, 33, 38, 39, 46, 49, 61, 67, 74, 78, 81, 83, 86, 96, 99, 102, 106, 111, 141, 148, 150], "polariz": [8, 35, 37, 46, 48, 49, 61, 66, 67, 74, 75, 76, 78, 88, 91, 98, 99, 111, 131, 132, 150], "imaginari": [8, 60, 65, 76, 86, 89, 98, 113, 124, 142, 144], "frequenc": [8, 43, 50, 55, 61, 73, 76, 78, 82, 83, 86, 88, 89, 91, 96, 98, 99, 113, 117, 124, 130, 131, 132, 142, 144, 150, 156], "entiti": [8, 11, 53], "addit": [8, 15, 16, 20, 21, 25, 29, 33, 40, 41, 46, 49, 55, 69, 75, 78, 89, 91, 122, 128, 141, 142, 143, 144, 149, 157], "multipol": [8, 47, 74, 91, 141], "magnet": [8, 20, 31, 46, 70, 74, 76, 81, 82, 89, 91, 98, 99, 102, 111, 120, 122, 125, 143, 148], "c_m": 8, "ldot": [8, 22, 25, 26, 28, 29, 30, 31, 46, 66, 72, 73, 74, 82, 86, 88, 94, 97, 113, 150], "k_n": 8, "c_6": [8, 9], "c_8": 8, "cdot": [8, 11, 14, 15, 16, 19, 22, 25, 28, 29, 30, 36, 55, 74, 82, 83, 86, 88, 89, 91, 94, 99, 100, 111], "k_7": 8, "k_9": 8, "london": [8, 47, 67], "finit": [8, 46, 48, 73, 84, 100, 113], "photon": [8, 69, 70, 73, 91, 99, 111, 123, 129, 130, 141, 144, 148, 150], "mediat": 8, "electromagnet": [8, 25, 46, 69, 74, 82, 88, 89, 99, 102, 103, 111, 129, 130], "retard": 8, "c6_drv": 8, "c6driver": 8, "c6_result": 8, "hf_c6": 8, "c6": 8, "realist": [8, 55], "navi": [8, 58, 70], "axhlin": [8, 14, 20, 101, 113, 120, 157], "28": [8, 14, 20, 24, 26, 28, 65, 70, 90, 98, 100, 101, 120, 122, 143, 148, 156], "34": [8, 20, 44, 65, 88, 90, 100, 101, 113, 120, 143, 150, 156], "bind": [8, 43, 59, 67, 69, 143, 144], "29": [8, 14, 20, 47, 70, 98, 100, 101, 120, 122, 124, 125, 143, 148, 150, 156], "equilibrium": [8, 20, 21, 33, 47, 52, 55, 60, 62, 66, 100, 124, 136, 155], "96": [8, 20, 67, 70, 90, 120, 124, 125, 143, 148, 156], "vvlvd90": [8, 67], "depict": [8, 72, 73], "cross": [8, 43, 47, 61, 66, 67, 70, 82, 92, 117, 123, 124, 130, 142, 144, 150], "vertic": [8, 60, 70, 72, 124, 144], "horizont": 8, "quit": [8, 19, 27, 55, 60, 83, 89, 98, 99, 111, 113, 133, 143, 144, 148, 149, 153, 157], "procedur": [8, 12, 14, 17, 27, 40, 46, 49, 60, 68, 72, 76, 82, 89, 98, 122, 148], "inclus": [8, 19, 21, 75, 125, 141, 147, 149], "nonbond": [8, 47], "introduct": [9, 16, 19, 32, 41, 56, 67, 101], "visual": [9, 12, 18, 21, 43, 59, 60, 62, 67, 70, 92, 96, 105, 113, 120, 123, 126, 130, 131, 133, 139, 140, 142, 143, 145, 152, 154, 155, 156, 157, 158, 159], "collinear": [9, 26, 31, 76], "noncollinear": [9, 31], "dispers": [9, 19, 35, 47, 67, 74, 144], "demonstr": [9, 16, 22, 75, 152], "rayleigh": [9, 22, 89, 129], "formal": [9, 17, 46, 67, 70, 91], "group": [9, 19, 34, 36, 41, 43, 47, 56, 82, 84, 91, 102, 130, 133], "canon": [10, 19, 31, 94, 105, 125, 153, 157], "matric": [10, 13, 14, 17, 21, 28, 29, 31, 33, 46, 49, 61, 67, 71, 72, 73, 76, 82, 94, 98, 111, 113, 139, 143, 144, 148, 153], "f_alpha": [10, 13], "against": [10, 17, 28, 96, 100, 149], "own": [10, 33, 42, 43, 55, 62, 101], "5482": [10, 156], "3452": 10, "7058": [10, 156], "5711": 10, "4946": 10, "perfect": [10, 14, 22, 39, 86, 88, 94, 115, 148], "duplic": 10, "extend": [10, 21, 43, 55, 82, 89, 91, 92, 98, 133, 144], "row": [10, 11, 26, 38, 45, 66, 82, 91, 94, 141, 143, 149], "s_ext": 10, "f_ext": 10, "encount": [10, 82, 89], "except": [10, 42, 46, 61, 72, 89, 117, 120, 143], "address": [10, 19, 43, 60, 111, 122, 123, 128, 143, 144, 149], "symmetr": [10, 11, 16, 21, 30, 33, 46, 47, 61, 70, 72, 76, 84, 89, 98, 102, 117, 122, 130, 141], "unitari": [10, 11, 15, 24, 67, 72, 94, 97, 113], "sigma_ext": 10, "u_ext": 10, "isclos": 10, "thereaft": [10, 38, 88, 94], "detect": [10, 76, 82, 120], "degeneraci": [10, 31, 141, 142, 143], "rectangular": [10, 45, 52, 94], "retriev": [10, 13, 25, 26, 39, 100, 113, 115, 133], "oao": 10, "chi": [10, 18, 26, 38, 41, 47, 91, 150], "straightforward": [10, 11, 21, 31, 45, 49, 68, 82, 86, 93, 99, 111, 113, 142, 143, 144], "readili": [10, 15, 26, 43, 82], "satisfi": [10, 16, 21, 46, 71], "sqrt": [10, 15, 18, 19, 20, 30, 31, 38, 55, 66, 70, 80, 86, 88, 89, 94, 96, 97, 106, 113, 122, 148, 151], "f_oao": 10, "ki": [10, 15, 39, 46, 66, 72, 82], "lj": [10, 39, 46, 47, 72], "c_oao": 10, "phi": [10, 22, 24, 25, 26, 30, 31, 38, 82, 84, 94, 96, 97, 100, 108, 150], "identifi": [10, 11, 28, 38, 45, 46, 56, 62, 70, 82, 83, 88, 97, 99, 100, 102, 111, 143, 144, 149], "kj": [10, 33, 46, 47, 62, 66, 72, 150], "everydai": [11, 74], "life": [11, 74, 151], "invers": [11, 20, 27, 45, 52, 60, 63, 66, 70, 82, 91, 113, 120, 125, 130, 143, 148, 150], "unchang": [11, 15, 63], "mechan": [11, 25, 35, 36, 39, 41, 45, 47, 51, 52, 53, 61, 64, 67, 74, 99, 102, 111, 151], "distinguish": [11, 15, 20, 74], "former": [11, 15, 19, 22, 38, 46, 100, 141, 144], "latter": [11, 16, 19, 31, 33, 46, 49, 58, 70, 74, 78, 84, 139, 143, 144, 149], "frame": [11, 65, 70, 74, 89, 130, 131, 132, 156], "sequenc": [11, 14, 67, 73, 76, 82, 98, 100], "map": [11, 16, 29, 108], "spectrum": [11, 18, 61, 67, 69, 99, 100, 102, 103, 106, 113, 124, 129, 130, 131, 134, 141, 143, 145, 148, 156, 158, 159], "intens": [11, 48, 49, 66, 67, 70, 72, 76, 81, 91, 96, 99, 102, 104, 106, 111, 124, 125, 130, 132, 143, 144, 146, 148, 149, 153, 156], "sigma_": [11, 102], "leftarrow": [11, 82, 102], "propto": [11, 74, 91, 102, 144], "psi_f": [11, 78, 94, 102], "psi_i": [11, 15, 19, 28, 72, 80, 102], "must": [11, 46, 55, 60, 64, 70, 82, 130, 131, 132, 142], "split": [11, 31, 33, 47, 102, 125, 141, 142, 143, 149, 153, 156, 159], "0pt": [11, 25, 28, 113], "14pt": 11, "spatial": [11, 15, 16, 18, 24, 25, 26, 29, 31, 33, 70, 91, 97, 113, 142, 143, 150], "action": [11, 29, 43, 74, 150], "commut": [11, 29, 31, 78, 88, 113], "therebi": [11, 15, 18, 22, 27], "fulfil": [11, 16, 21, 27, 38, 55, 84, 117, 143], "member": 11, "law": [11, 47, 55, 91, 150], "belong": [11, 82, 102, 153], "ourselv": [11, 49], "geometr": [11, 47, 52, 60, 65, 66, 67, 99, 111, 117, 130, 153], "plane": [11, 31, 47, 74, 82, 120, 142, 144], "everi": [11, 21, 26, 43, 49, 82, 100, 101, 108, 122], "crystal": 11, "possess": [11, 74, 142, 143, 144], "translat": [11, 20, 43, 46, 60, 67, 69, 97, 130], "noth": 11, "_n": [11, 14, 15, 16, 22, 25, 27, 28, 30, 46, 70, 72, 97, 136], "princip": [11, 66, 111], "perpendicular": [11, 61, 74, 76, 82, 89, 98], "_h": [11, 76, 91, 98], "_v": [11, 21], "bisect": 11, "c_2": 11, "_d": 11, "invert": [11, 20, 45], "through": [11, 17, 22, 42, 43, 46, 47, 52, 55, 70, 72, 73, 74, 76, 91, 96, 108, 111, 113, 117, 123, 130, 131, 132, 133, 143, 144, 156, 157, 159], "improp": [11, 47, 74, 82], "rotoreflect": 11, "flowchart": 11, "knowledg": [11, 16, 55, 108, 122], "regard": [11, 70, 72, 73], "asymmetr": [11, 130, 151], "distribut": [11, 20, 26, 31, 35, 36, 42, 43, 47, 55, 71, 84, 143, 149, 151], "c_n": [11, 28], "moreov": [11, 12, 25, 82, 105, 115], "nv": 11, "superimpos": [11, 74], "mirror": [11, 74], "imag": [11, 67, 74, 86, 113, 120, 124, 133, 142, 144, 159], "said": [11, 31, 74, 91], "chiral": [11, 67, 74, 82], "inabl": [11, 19], "direct": [11, 17, 20, 26, 29, 33, 39, 49, 60, 64, 67, 70, 72, 73, 74, 82, 88, 91, 96, 98, 102, 117, 118, 120, 122, 125, 142, 143, 148], "enantiom": [11, 74], "s_n": 11, "presenc": [11, 22, 33, 46, 49, 55, 69, 74, 82, 83, 84, 89, 96, 120], "irreduc": [11, 102], "irrep": 11, "abelian": 11, "xz": [11, 17, 31, 38, 61, 89, 142], "yz": [11, 17, 38, 61, 89, 142], "a_1": [11, 74], "a_": [11, 36, 41, 46, 82, 86, 91, 106, 113, 150], "r_z": [11, 82], "r_y": [11, 102], "r_x": [11, 82], "a_g": [11, 102], "xy": [11, 17, 31, 38, 52, 61, 89, 120, 142], "1g": 11, "2g": [11, 102], "1u": 11, "2u": 11, "3u": [11, 102], "gamma": [11, 15, 17, 21, 24, 31, 33, 46, 47, 60, 61, 70, 71, 74, 75, 76, 81, 83, 91, 98, 102, 105, 106, 113, 117, 124, 125, 143, 144, 148, 151], "psi": [11, 15, 16, 22, 24, 25, 26, 27, 28, 30, 31, 46, 70, 72, 82, 88, 90, 96, 97, 99, 100, 111, 150], "psi_1": [11, 19, 25, 29, 97, 150], "otim": [11, 25, 26, 27, 30, 91, 102], "psi_2": [11, 19, 29, 97], "psi_n": [11, 19, 25, 70, 72, 73, 150], "variat": [12, 15, 16, 20, 25, 36, 41, 46, 49, 67, 78, 86, 97, 99, 102, 143], "sens": [12, 16, 27, 97], "cornerston": 12, "underli": [12, 19, 25, 26, 43, 68, 104, 105, 108], "mol_xyz": [13, 81], "number_of_atom": [13, 38, 52, 130, 131, 132, 153, 156], "10f": [13, 22, 153], "0265782198": 13, "dictionari": [13, 33, 62, 100, 113, 131, 150], "norbit": 13, "eri_thresh": 13, "qq_type": 13, "c_beta": [13, 24], "e_beta": 13, "f_beta": 13, "55119961": 13, "33473347": 13, "69692651": 13, "56605275": 13, "49289827": 13, "18486487": 13, "25566978": 13, "78604709": 13, "85103488": 13, "16387193": 13, "20030818": 13, "25366153": 13, "44422793": 13, "4755769": 13, "67329727": 13, "8679223": 13, "93111284": 13, "4430781": 13, "48048696": 13, "28268216": 13, "334531": 13, "50569214": 13, "86065795": 13, "14355137": 13, "static": [13, 23, 38, 46, 49, 74, 76, 83, 84, 89, 96, 98, 99, 102, 111, 121, 128, 147, 149, 155, 157], "html": [13, 42, 43, 102, 153, 157], "download": [13, 42, 43, 92], "lab": [13, 42], "view": [13, 18, 19, 25, 39, 47, 59, 60, 62, 65, 70, 82, 86, 90, 92, 94, 102, 124, 130, 131, 132, 133, 136, 137, 139, 148, 154, 156, 157, 159], "pull": [13, 39, 98, 102], "02698419": 14, "12f": [14, 25, 33], "343638157670": 14, "dure": [14, 19, 20, 21, 33, 52, 58, 65, 92, 120, 122, 131, 156], "unintuit": 14, "bmatrix": [14, 45, 94, 97, 113], "f_": [14, 15, 16, 21, 46, 49, 70, 71, 72, 76, 80, 83, 84, 86, 89, 106, 111, 113], "ov": [14, 17, 22, 33, 38, 72, 86, 97], "vo": [14, 33, 38, 67, 97], "vanish": [14, 15, 29, 38, 46, 48, 50, 60, 64, 65, 66, 70, 74, 82, 84, 91, 117], "error_rh": 14, "68": [14, 20, 24, 26, 65, 120, 122, 143, 156], "84975229": 14, "09e": [14, 72, 89], "69": [14, 20, 60, 101, 120, 124, 143, 153, 156], "95937641": 14, "88e": [14, 89], "34743276": 14, "83e": [14, 72], "46688910": 14, "23e": [14, 72], "74058933": 14, "18e": [14, 72, 76], "55859127": 14, "41e": [14, 148], "86908635": 14, "26e": [14, 72], "97444165": 14, "82e": [14, 21, 72, 76, 89, 148], "00992921": 14, "74e": [14, 72], "02143957": 14, "57e": [14, 72], "02519173": 14, "89e": [14, 21, 72, 89], "02640379": 14, "06e": [14, 72], "02679653": 14, "02692347": 14, "64e": [14, 72, 89], "02696455": 14, "31e": 14, "02697784": 14, "30e": 14, "02698213": 14, "01e": [14, 21, 72, 89, 148], "17": [14, 19, 20, 21, 25, 26, 62, 65, 67, 72, 80, 86, 89, 90, 98, 99, 100, 101, 120, 122, 124, 125, 129, 143, 150, 156], "02698352": 14, "71e": [14, 21, 72, 89], "02698397": 14, "19": [14, 17, 19, 22, 24, 25, 58, 65, 67, 70, 89, 90, 100, 101, 113, 120, 122, 124, 125, 131, 143, 144, 145, 148, 149, 150, 156], "02698412": 14, "54e": [14, 21], "02698416": 14, "15e": [14, 72], "02698418": 14, "79e": 14, "22": [14, 28, 62, 67, 70, 89, 90, 92, 101, 120, 122, 124, 125, 142, 143, 144, 156], "02e": [14, 21], "23": [14, 20, 24, 65, 70, 90, 101, 120, 122, 124, 125, 143, 148, 156], "80e": 14, "07e": [14, 72], "45e": [14, 89], "96e": [14, 72], "12e": [14, 89], "07": [14, 20, 31, 70, 72, 75, 76, 90, 94, 101, 120, 124, 125, 143], "rothaan": 14, "hall": 14, "suffer": [14, 18, 20, 22, 46, 72], "pul80": [14, 67], "pul82": [14, 67], "sel93": [14, 67], "w_i": [14, 18], "preserv": [14, 16, 38, 97, 143], "impos": [14, 46, 100, 144], "condit": [14, 16, 46, 49, 66, 71, 82, 86, 89, 91, 117], "strict": [14, 16], "strictli": [14, 142], "w_j": 14, "constrain": [14, 15, 16, 46, 47, 64, 153], "lagrang": [14, 15, 16, 38, 41, 46, 67], "convent": [14, 15, 82, 96, 102, 111, 113, 150], "arriv": [14, 15, 25, 26, 38, 60, 82, 86, 100, 150], "pmatrix": [14, 15, 25, 26, 28, 30, 31, 36, 38, 45, 46, 71, 82, 86, 88, 94, 97, 99, 113], "1n": 14, "vdot": [14, 15, 28, 30, 36, 81, 94], "ddot": [14, 15, 28, 30, 36, 94], "n1": 14, "w_1": 14, "w_n": 14, "modif": [14, 38, 101], "But": [14, 16, 20, 21, 43, 46, 120], "extra": [14, 92, 143, 149], "hamper": [14, 16], "optimum": 14, "stabilit": 14, "error_dii": 14, "88501761": 14, "37e": [14, 89], "97016719": 14, "01483442": 14, "34e": [14, 89], "02676704": 14, "29e": [14, 21, 72, 98], "02698021": 14, "32e": [14, 72], "02698392": 14, "04e": 14, "97e": 14, "43e": [14, 72, 76], "roothaan": 14, "yscale": [14, 18], "log": [14, 18, 65, 151], "linestyl": [14, 20, 99, 106, 120, 148], "grei": [14, 99], "frameon": [14, 58, 96, 157], "vmatrix": [15, 30], "min_": [15, 16], "ji": [15, 25, 46, 52, 86], "psi_j": [15, 28, 72, 80, 86], "search": [15, 16, 43, 48, 60, 64, 108], "mbox": [15, 84, 113], "varepsilon_0": [15, 16, 19, 25, 36, 39, 41, 82, 150], "psi_k": [15, 25, 72, 100], "overal": [15, 21, 30, 31, 38, 88, 97], "among": [15, 19, 43, 48, 88, 97], "emploi": [15, 17, 19, 46, 48, 49, 78, 91, 94, 100, 144], "lcao": [15, 26, 38, 46], "alpha_": [15, 38, 61, 75, 76, 82, 83, 88, 89, 91, 111, 113], "beta_": [15, 24, 76, 83, 91, 98, 144], "tr": [15, 38, 70], "varepsilon_i": [15, 19, 33, 49, 70, 72, 86], "varepsilon_a": [15, 33, 49, 70, 72, 86], "ioniz": [15, 67, 68, 106, 141, 144, 145, 146], "ie": [15, 143, 144, 145, 146, 148], "affin": [15, 68, 144], "ea": [15, 84, 99], "e_i": [15, 80, 82], "e_a": [15, 39, 52, 99], "frozen": [15, 31, 41, 58, 75, 82, 143], "excit": [15, 18, 19, 21, 22, 26, 27, 29, 33, 38, 43, 51, 52, 67, 68, 69, 71, 73, 75, 78, 80, 89, 90, 92, 93, 94, 96, 98, 99, 100, 101, 102, 103, 104, 105, 106, 115, 117, 118, 120, 122, 123, 124, 125, 128, 129, 130, 141, 142, 144, 145, 146, 147, 149, 151, 158], "summat": [15, 17, 24, 25, 28, 38, 73, 82, 88, 91, 96, 97, 111, 117], "customari": [15, 21], "compon": [15, 16, 19, 22, 25, 26, 27, 31, 33, 38, 40, 43, 46, 49, 61, 67, 70, 74, 75, 76, 81, 82, 84, 88, 91, 96, 98, 100, 122, 125, 131, 142, 143, 144, 150], "isol": [16, 39, 80, 83, 88, 99, 111], "psi_0": [16, 70, 72, 73, 78, 80, 94], "eq": [16, 19, 46, 49, 61, 66, 72], "sch": 16, "e_0": [16, 27, 33, 46, 70, 72, 73, 82, 83, 111], "extern": [16, 31, 33, 38, 40, 43, 46, 49, 74, 78, 82, 83, 86, 88, 91, 96, 100, 102, 103, 111], "nabla_i": 16, "z_k": [16, 61, 84], "_k": [16, 61, 66], "proton": [16, 150], "task": [16, 43, 55, 88, 140, 144], "n_0": 16, "cartesian": [16, 31, 38, 49, 56, 60, 61, 82, 88, 91, 96, 125, 142, 150], "1920": [16, 156], "thoma": 16, "fermi": [16, 21, 28, 120, 150], "legitim": 16, "tild": [16, 25, 36, 46, 60, 66, 70, 72, 76, 89, 96, 97], "uniqu": [16, 29, 36, 38, 45, 82, 100, 143, 144, 153], "univers": [16, 34, 67], "undefin": 16, "geq": 16, "detemin": 16, "leq": [16, 46], "prohibit": 16, "theoret": [16, 43, 67, 76, 91, 103, 123, 129, 144], "still": [16, 20, 21, 47, 62, 66, 82, 92, 101, 120, 133, 144, 148, 149], "recip": 16, "reformul": [16, 99, 143], "wider": 16, "nabla": [16, 18, 19, 25, 60, 82, 84, 91, 108, 150], "levi": [16, 31, 67], "deliv": [16, 82], "lev79": [16, 67], "stationari": [16, 36, 38, 45, 46, 47, 50, 60, 91, 103], "altern": [16, 17, 19, 21, 31, 49, 62, 73, 91, 100, 113, 124, 133, 142, 143, 144, 148, 149, 159], "angular": [17, 26, 31, 61, 73, 76, 82, 88, 89, 91, 96, 98, 100, 128, 130], "m_l": [17, 26], "get_dimension_of_basi": [17, 22, 86, 88, 94, 96, 115], "h_1": [17, 90, 101, 124], "h_2": 17, "2p_y": 17, "3p_y": 17, "2p_z": 17, "3p_z": 17, "2p_x": 17, "3p_x": 17, "3d_": 17, "expos": [17, 99, 103], "linmom_drv": 17, "linearmomentumintegralsdriv": 17, "linmom_mat": 17, "p_x": [17, 143], "x_to_numpi": [17, 18, 39, 70, 75, 83, 88, 113, 144], "p_y": 17, "y_to_numpi": [17, 18, 39, 70, 75, 83, 144], "p_z": [17, 24, 78], "mu_x": [17, 33, 39, 61, 83, 88, 102, 105, 113], "mu_i": [17, 33, 39, 61, 66, 82, 83, 102, 105, 113], "angmom_drv": 17, "angularmomentumintegralsdriv": 17, "angmom_mat": 17, "m_x": [17, 102, 105], "m_y": [17, 102, 105], "m_z": [17, 102, 105], "omega_": [17, 25, 29, 46, 49, 61, 70, 73, 75, 76, 78, 82, 83, 88, 91, 98, 99, 100, 117, 130, 150], "mu_z_mo": 17, "deduc": [17, 73], "mu_z_ao": [17, 86], "bp": 17, "cq": 17, "forth": [17, 55, 94], "back": [17, 20, 43, 45, 55, 70, 73, 90, 123, 133, 153], "assert_allclos": [17, 28, 86], "atol": [17, 28, 86], "reli": [17, 73], "consum": [17, 47], "cost": [17, 47, 52, 60, 80, 89, 120, 128, 136, 139, 142, 143, 144, 149], "demand": [17, 55], "g_1": [17, 22], "abc": [17, 22], "g_2": [17, 22], "cr": [17, 22, 33, 120], "abr": [17, 22], "g_3": [17, 22], "aqr": [17, 22], "g_mo": 17, "eri": [17, 20, 25, 33, 70, 72, 76, 86, 89, 98, 113, 120, 125, 143, 148], "physicist": [17, 25, 29, 33, 46, 70, 72, 113, 150], "erimo_drv": [17, 22, 86], "mointegralsdriv": [17, 22, 25, 33, 70, 86, 113], "phys_oovv": [17, 70, 113], "oo": [17, 72, 86], "vv": [17, 72, 86], "chem_ovov": [17, 22, 70, 86], "swapax": 17, "ovov": [17, 22, 70, 86], "screen": [17, 20, 70, 72, 76, 89, 98, 120, 125, 143, 144, 148], "parallel": [17, 43, 61, 71, 73, 74, 76, 89, 98], "gator": [17, 42, 67, 70, 72, 124, 125, 142, 144, 145, 153], "d_ij": 17, "k_ij": 17, "acbd": 17, "g_ivjv": 17, "db": 17, "xc": [18, 19, 20, 46, 49, 80, 105, 106, 108, 113, 128, 136, 142, 143, 144], "log3": 18, "quadratur": [18, 67], "ta95": [18, 67], "ssf": 18, "partit": [18, 19, 29, 35, 46, 68, 70, 73], "ssf96": [18, 67], "amount": [18, 19, 20, 25, 43, 71, 105, 120, 143, 144, 149], "assess": [18, 67, 96], "creation": [18, 73, 97, 111, 141, 143, 144], "number_of_point": 18, "40720": [18, 76, 89, 98], "sphere": [18, 59, 70, 84, 90, 130, 131, 132, 133, 136, 137, 139, 154, 156, 159], "radiu": [18, 38, 47, 52, 60, 82, 100, 143, 150], "a_0": [18, 46, 74, 150], "grid_xyz": 18, "ngrid": 18, "52911721": 18, "insid": [18, 34, 41, 47, 90, 100], "5398": 18, "35322": 18, "Not": [18, 46, 89], "surprisingli": 18, "volum": [18, 28, 30, 34, 55, 67, 150], "400": [18, 59, 62, 65, 69, 92, 120, 124, 133, 136, 159], "addmodel": [18, 39, 59, 62, 65, 70, 90, 124, 130, 131, 132, 133, 136, 137, 139, 154, 156, 157, 159], "setstyl": [18, 39, 47, 59, 62, 65, 70, 90, 92, 124, 130, 131, 132, 133, 136, 137, 139, 154, 156, 157, 159], "stick": [18, 39, 47, 59, 62, 65, 70, 90, 92, 124, 130, 131, 132, 133, 136, 137, 139, 154, 156, 157, 159], "addsurfac": 18, "vdw": [18, 47], "opac": [18, 70, 157], "elem": [18, 159], "zoomto": [18, 59, 62, 65, 130, 131, 132, 133, 156], "radial": [18, 120, 143, 152], "maxima": [18, 120], "rad_dist": 18, "patch": [18, 60], "hist": 18, "bin": 18, "def2": [18, 26, 76, 81, 83, 88, 89, 96, 98, 120], "svpd": [18, 26, 76, 83, 89, 98], "vari": [18, 19, 47, 55, 96, 128, 143, 144, 149], "eight": [18, 102, 122], "107": [18, 67, 156], "900": [18, 113, 156], "n_grid_point": 18, "n_elec": 18, "4404": [18, 156], "10536": [18, 47], "20678": 18, "63844": 18, "147024": 18, "348468": 18, "1107906": 18, "ten": [18, 27, 29, 35, 143], "vare": 18, "ax1": [18, 20, 100, 124], "add_subplot": [18, 131], "111": [18, 65, 76, 156], "annot": [18, 99, 120], "gga": 18, "xytext": [18, 99], "arrowprop": [18, 99], "arrowstyl": 18, "set_xlim": [18, 20, 100, 124], "ax2": [18, 20, 100, 124], "twini": 18, "set_xticklabel": 18, "set_xlabel": [18, 20, 58, 59, 60, 100], "insensit": [18, 41, 144], "regoin": 18, "simul": [18, 43, 47, 53, 55, 67, 68, 70, 147], "spectroscopi": [18, 43, 48, 61, 66, 67, 69, 82, 93, 96, 102, 103, 113, 142, 143, 145, 146, 149, 150], "lock": 18, "four": [18, 19, 24, 29, 36, 39, 41, 46, 47, 65, 67, 71, 76, 80, 82, 97, 102, 124, 132, 133, 141, 143, 144, 148, 150, 151, 153], "frequent": [18, 19, 82, 101], "41": [18, 20, 24, 39, 65, 67, 72, 86, 89, 90, 91, 97, 101, 120, 122, 124, 125, 131, 143, 156], "fill_between": [18, 142], "get_xaxis_transform": 18, "85": [18, 20, 33, 70, 100, 120, 131, 143, 148, 156], "alik": 18, "occation": 18, "alarmingli": 18, "earli": 19, "led": [19, 20, 78, 91], "inaccur": 19, "1965": [19, 67, 156], "ks65": [19, 67], "propos": [19, 60], "correspondingli": [19, 91], "iint": 19, "act": [19, 25, 29, 39, 47, 55, 73, 90, 111], "conserv": [19, 36, 38, 43, 55, 67, 91, 117], "eff": [19, 20, 71, 72, 108], "unknown": [19, 46, 49, 60, 86], "justifi": [19, 115], "inaccuraci": 19, "classifi": [19, 38, 91, 100], "variou": [19, 43, 56, 70, 72, 91, 104, 123, 141, 142], "parameter": [19, 43, 90, 96, 111, 143], "argument": [19, 28, 88, 89], "categori": [19, 26, 35, 38], "type": [19, 43, 46, 47, 56, 58, 62, 70, 80, 81, 100, 120, 128, 129, 144, 149, 151, 153], "highlight": [19, 21, 82], "promin": 19, "assum": [19, 21, 25, 27, 38, 49, 64, 82, 89, 91, 94, 96, 98, 99, 111, 113, 132, 133, 154, 156], "implicitli": [19, 27, 46, 91, 96, 133], "understood": [19, 20, 27, 39, 82, 100, 113], "decompos": [19, 38, 61, 125, 142], "jacob": 19, "ladder": [19, 31, 67], "sole": [19, 82], "almost": [19, 20, 90, 126, 144, 148], "dirac": [19, 26, 28, 67], "dir30": [19, 67], "vosko": [19, 67], "wilk": [19, 67], "nussair": 19, "vwn80": [19, 67], "de": [19, 38, 46, 67, 73, 75, 83, 153], "facto": 19, "undertaken": 19, "sha71": [19, 67], "herman": [19, 67], "worker": 19, "hvdo69": [19, 67], "1970": 19, "unsuccess": 19, "1988": [19, 67], "reliabl": [19, 43, 67, 83, 98, 128, 149], "b88": [19, 143], "beck": [19, 67], "bec88": [19, 67], "notabl": 19, "lee": [19, 67], "yang": [19, 67], "parr": [19, 67], "lyp": [19, 143], "lyp88": [19, 67], "perdew": [19, 67], "burk": 19, "ernzerhof": [19, 67], "es99": [19, 67], "bec93": [19, 67], "sdcf94": [19, 67], "pursu": 19, "decad": [19, 91], "tao": [19, 67], "2003": [19, 67, 156], "staroverov": [19, 67], "scuseria": [19, 67], "tpss03": [19, 67], "truhlar": [19, 67], "zt11": [19, 67], "revis": [19, 67], "wjy": [19, 67], "incorpor": [19, 83], "vwn": [19, 143], "gold": 19, "besid": [19, 46], "minnesota": 19, "famili": [19, 26, 38, 128, 149], "consider": [19, 46, 47, 71, 144, 148], "short": [19, 20, 21, 35, 38, 43, 47, 53, 82, 91, 120, 133, 149], "asymptot": [19, 67, 80, 149], "behavior": [19, 53, 67, 80, 91], "optic": [19, 62, 67, 74, 82, 99, 111, 113], "cam": [19, 67, 98, 128, 149], "yth04": [19, 67], "initio": [19, 52, 67, 68, 80], "transfer": [19, 38, 47, 55, 67, 76, 80, 90, 97, 98, 104, 113, 128, 149, 153], "mention": [19, 21, 55, 96, 101], "recent": [19, 54, 142, 144], "year": 19, "empir": [19, 35, 43, 59], "strategi": [19, 21, 70, 73], "grimm": [19, 67], "ceh": [19, 67], "gaek10": [19, 67], "who": [19, 108], "d3": [19, 83], "d4": [19, 83], "successfulli": 19, "strongli": [19, 45, 105, 113, 143, 149], "viabl": [19, 125], "draw": 19, "built": [19, 38, 75, 124, 125, 143, 144], "treatment": [19, 53, 67, 72, 75, 144], "broken": [19, 20, 120], "simplic": [20, 82, 99, 101, 111, 122, 144], "textbook": [20, 43], "dissoci": [20, 21, 52, 92, 120], "angstrom": [20, 21, 33, 34, 36, 39, 41, 52, 92, 100, 120, 122, 131, 150, 153], "e_h_hf": [20, 21, 120], "e_h_blyp": 20, "cidrv": [20, 21, 75, 101], "e_h_fci": 20, "h2": [20, 31, 52, 120], "mol_templ": [20, 21, 33, 52, 120], "h2dist": 20, "dft_drv": 20, "distlist": [20, 21, 33, 52, 120], "65": [20, 47, 70, 76, 89, 91, 101, 120, 122, 143, 148, 156], "e_blyp": 20, "dft_result": [20, 144], "y1": [20, 60, 81, 106, 130, 142, 148], "627": [20, 92, 122, 136, 150], "y2": [20, 60, 106, 142, 148], "y3": [20, 60, 106], "rhf": [20, 21, 24, 33, 120, 121, 143, 144], "kcal": [20, 44, 58, 59, 65, 122, 136, 150], "mol": [20, 33, 44, 47, 52, 58, 59, 61, 62, 65, 67, 122, 130, 131, 136, 143, 144, 145, 148, 150, 153, 156, 157], "dz": [20, 75], "closer": [20, 33, 43, 52, 55, 75, 78, 101, 143, 144], "On": [20, 21, 52, 67, 68, 72], "goe": [20, 74], "significantli": [20, 21, 27, 69, 80, 89, 90, 92, 101, 143, 144, 149], "partli": [20, 60], "bs_drv": 20, "guess_unpaired_electron": 20, "e_b": [20, 99], "bs_result": 20, "y4": 20, "set_ylabel": [20, 58, 59, 60, 100], "axin": 20, "inset_ax": 20, "indicate_inset_zoom": 20, "energt": 20, "bifurc": 20, "poorli": [20, 21, 90], "contamin": [20, 122, 144, 148], "realli": [20, 43], "transit": [20, 21, 33, 43, 45, 46, 47, 48, 56, 60, 61, 67, 69, 70, 72, 73, 75, 78, 80, 82, 86, 90, 99, 101, 102, 103, 104, 105, 113, 117, 120, 123, 124, 125, 128, 129, 132, 141, 142, 143, 144, 145, 147, 148, 149, 150, 151, 158], "regim": [20, 61, 91, 141, 144], "bs_tensor": 20, "rho1_a": 20, "get_dens": [20, 28], "rho1_b": 20, "rho2_a": 20, "rho2_b": 20, "sharei": 20, "suptitl": 20, "profil": [20, 65, 70, 120], "pass": [20, 76], "suddenli": 20, "mostli": [20, 66, 74, 101, 124], "becaus": [20, 21, 41, 45, 47, 52, 60, 70, 71, 72, 73, 90, 91, 101, 149], "fundament": [20, 43, 45, 66, 67, 91, 130, 150], "fragment": [20, 21, 72, 81, 120, 153], "modern": [20, 43, 67], "absenc": [20, 91, 100, 122], "relativist": [20, 67, 89, 141, 144], "unphys": [20, 41, 143, 144], "promis": 20, "rho_2": 20, "r_1": 20, "r_2": 20, "henc": [20, 33, 46, 49, 66, 72, 90], "behav": [20, 22, 46, 67, 82, 91, 105], "get_ontop": 20, "twodm": 20, "active_orbit": 20, "den_i": 20, "aodensitymatrix": [20, 70], "_get_inactive_dens": 20, "denmat": [20, 70], "rest": [20, 21, 33, 70, 82, 100, 133, 142, 150], "rho_i": [20, 153], "ontop": 20, "mcscf_drv": [20, 21, 90, 92, 101, 124, 144], "mcscfdriver": [20, 21, 24, 90, 101, 120, 122, 124, 144], "den": 20, "get_total_dens": 20, "rho1": [20, 143], "ontop1": 20, "ci_driv": 20, "rho2": [20, 143], "ontop2": 20, "rho": [20, 31, 61, 105, 108, 143], "simultan": [20, 21, 30, 74, 113, 122, 124, 143, 144], "likelihood": [20, 47], "push": [20, 39, 98, 143], "toward": [20, 39, 60, 67, 69, 75, 143, 149], "littl": [20, 143], "unlik": [20, 21, 101], "rho_": [20, 153], "uncorrel": [20, 89], "quadrat": [20, 60, 64, 74, 83, 89, 117], "pm": [20, 21, 31, 46, 88], "arbitrarili": [20, 82], "radic": 20, "rho_a": 20, "rho_b": 20, "weird": [20, 21], "chose": [20, 143], "imagin": [20, 72, 73], "predict": [20, 67, 91, 92, 102], "reminesc": 20, "retain": [20, 38], "briefli": [20, 49], "bound": [20, 47, 144], "local": [20, 26, 34, 43, 46, 47, 50, 52, 55, 57, 60, 67, 69, 71, 72, 80, 89, 98, 133, 141, 142, 144, 153], "particularli": [20, 70, 122, 133, 143, 149], "blindli": 20, "tri": 20, "motiv": [20, 21, 33, 47, 69, 101], "gain": [20, 43, 90, 144], "anyth": 20, "analogu": 20, "dr": 20, "compute_pdft": 20, "tblyp": 20, "mcscf_result": [20, 21, 90, 101, 122, 124, 144], "e_h_tblyp": 20, "e_tblyp": 20, "y5": 20, "gentler": 20, "Of": [20, 21, 47, 55, 72, 130], "multi": [20, 21, 24, 30, 45, 90, 101, 102, 117, 120, 124, 149, 150, 152, 153], "bfg": [20, 60, 90, 101, 120, 124], "496396614": 20, "496403222": 20, "496403255": 20, "49640325498824395": 20, "00000": [20, 33, 72, 75, 100, 101, 113, 120, 124, 144, 151], "No": [20, 24, 34, 36, 41, 70, 90, 101, 120, 122, 124, 125, 133, 143, 148], "11565": 20, "58": [20, 25, 67, 90, 101, 120, 122, 124, 143, 144, 148, 150, 156], "51": [20, 59, 67, 81, 90, 101, 120, 122, 124, 143, 156], "51785": 20, "31509": 20, "35": [20, 24, 52, 65, 67, 70, 90, 100, 101, 120, 122, 124, 125, 143, 156], "94": [20, 24, 67, 70, 89, 98, 101, 120, 124, 131, 143, 148, 156], "1p0": [20, 24, 70, 90, 101, 120, 122, 124, 125, 143, 148], "deby": [20, 33, 84, 90, 101, 120, 124], "superposit": [20, 70, 120, 122, 125, 143, 148], "cauchi": [20, 70, 72, 76, 98, 120, 125, 143, 148, 151], "schwarz": [20, 70, 72, 76, 89, 98, 120, 125, 143, 148], "mode": [20, 43, 50, 61, 65, 66, 70, 120, 125, 130, 131, 132, 141, 143, 144, 148, 155], "5291772109": [20, 120], "sec": [20, 70, 72, 76, 89, 98, 120, 125, 143, 148], "sad": [20, 70, 120, 125, 143, 148], "095959327021": [20, 120], "100056242572": [20, 120], "02692675": [20, 120], "00838888": [20, 120], "00000000": [20, 25, 26, 28, 38, 70, 72, 88, 89, 92, 94, 96, 102, 105, 113, 115, 120, 125, 143, 148, 157], "100153689745": [20, 120], "0000974472": [20, 120], "00051916": [20, 120], "00017723": [20, 120], "00493758": [20, 120], "100153764817": [20, 120], "0000000751": [20, 120], "00001420": [20, 120], "00000490": [20, 120], "00030702": [20, 120], "100153764873": [20, 120], "0000000001": [20, 120, 143], "00000815": [20, 120], "1001537649": [20, 120], "6293309758": [20, 120], "0000000003": [20, 120, 143], "52504": [20, 120], "38": [20, 24, 26, 65, 67, 70, 90, 101, 120, 122, 124, 125, 143, 148, 156], "14359": [20, 120], "53961": [20, 120], "78": [20, 44, 70, 72, 90, 120, 124, 130, 143, 148, 156], "79480": [20, 120], "47": [20, 24, 26, 67, 72, 89, 90, 101, 120, 122, 124, 125, 143, 156], "28713": [20, 120], "63": [20, 28, 72, 98, 101, 120, 122, 125, 143, 156], "143566377": 20, "148744377": 20, "148804711": 20, "149285428": 20, "149310085": 20, "5e": [20, 75, 90, 101, 120, 124, 150], "149314174": 20, "149314195": 20, "149314199": 20, "149314200": 20, "1493141999268626": 20, "98226": 20, "01774": 20, "982": 20, "33023": 20, "018": [20, 70, 125], "11039": 20, "39": [20, 70, 90, 101, 120, 122, 125, 131, 143, 156], "35559": 20, "77": [20, 67, 76, 89, 90, 100, 101, 120, 125, 131, 143, 156], "44574": 20, "01604": 20, "49": [20, 38, 59, 81, 89, 90, 100, 101, 122, 124, 125, 143, 154, 156], "000010": 20, "000025": 20, "000015": 20, "000039": [20, 81], "000235": 20, "000596": 20, "000598": 20, "052521357": 20, "077746302": 20, "082349570": 20, "082358066": 20, "082364708": 20, "082364599": 20, "082365046": 20, "082365361": 20, "082365882": 20, "082366076": 20, "082366110": 20, "082366111": 20, "082366111035586": 20, "99459": 20, "00541": 20, "995": [20, 26], "42354": 20, "43": [20, 24, 26, 44, 67, 70, 81, 90, 101, 120, 122, 124, 143, 156], "005": [20, 26], "56953": 20, "44": [20, 24, 44, 78, 81, 101, 120, 122, 125, 130, 143, 148, 156], "26170": 20, "72": [20, 89, 90, 102, 105, 120, 124, 143, 156], "71": [20, 24, 72, 89, 101, 120, 143, 148, 156], "49397": 20, "03346": 20, "54": [20, 70, 90, 100, 101, 120, 122, 124, 143, 148, 156], "03348": 20, "000004": [20, 81, 101, 120], "000173": 20, "000441": 20, "000174": 20, "140699969": 20, "142676262": 20, "142880436": 20, "142880613": 20, "142880728": 20, "142880744": 20, "142880752": 20, "1428807519481459": 20, "99327": 20, "00673": 20, "993": [20, 70], "39893": 20, "45658": 20, "28012": 20, "47279": 20, "01948": 20, "53": [20, 24, 62, 67, 91, 98, 100, 101, 122, 125, 143, 148, 156], "000001": [20, 120], "000002": [20, 81, 101, 120], "000006": 20, "000262": 20, "000666": 20, "325": [20, 150], "157198837": 20, "157569007": 20, "157610561": 20, "157610575": 20, "157610614": 20, "157610618": 20, "157610623": 20, "1576106228624794": 20, "99246": 20, "00754": 20, "992": [20, 101], "38799": 20, "008": 20, "40306": 20, "28957": 20, "46548": 20, "79": [20, 70, 100, 120, 131, 143, 156], "80": [20, 24, 62, 67, 92, 101, 120, 143, 156], "01397": 20, "000296": 20, "000753": 20, "165420916": 20, "165729971": 20, "165764279": 20, "165764286": 20, "165764335": 20, "1657643354660694": 20, "99152": 20, "00848": 20, "37784": 20, "35251": 20, "29914": 20, "45962": 20, "00965": 20, "00966": 20, "000003": 20, "000007": 20, "000221": 20, "000563": 20, "375": 20, "168853647": 20, "169112740": 20, "169140865": 20, "169140864": 20, "169140933": 20, "1691409331842553": 20, "99043": 20, "00957": 20, "990": 20, "36845": 20, "010": 20, "30407": 20, "30871": 20, "45561": 20, "56": [20, 67, 81, 100, 101, 124, 143, 156], "00668": 20, "00670": 20, "000005": [20, 81], "000013": [20, 81], "000273": 20, "000693": 20, "168787524": 20, "169005343": 20, "169028405": 20, "169028485": 20, "169028485352778": 20, "98919": 20, "01081": 20, "989": 20, "35972": 20, "011": [20, 67, 125], "25869": 20, "92": [20, 67, 101, 120, 143, 156], "31822": 20, "45263": 20, "61": [20, 67, 70, 120, 143, 156], "00523": 20, "000259": 20, "000659": 20, "161128629": 20, "161808476": 20, "161869221": 20, "161869236": 20, "161869579": 20, "161869641": 20, "161869653": 20, "1618696533991333": 20, "98614": 20, "01386": [20, 75], "986": [20, 144], "34398": 20, "014": [20, 67, 125], "17736": 20, "33713": 20, "44911": 20, "00720": 20, "32": [20, 24, 28, 61, 62, 70, 76, 97, 101, 113, 120, 122, 124, 125, 131, 143, 148, 156], "00721": 20, "000018": [20, 81], "000012": 20, "000030": 20, "000237": 20, "000604": 20, "000238": 20, "000605": 20, "148779644": 20, "149275807": 20, "149313834": 20, "149313851": 20, "149314144": 20, "149314192": 20, "1493142001660392": 20, "98225": 20, "01775": 20, "11032": 20, "44580": 20, "01603": 20, "000236": 20, "000600": 20, "117019706": 20, "118299607": 20, "118361209": 20, "118362130": 20, "118362287": 20, "118362304": 20, "1183623041338808": 20, "97103": 20, "02897": 20, "971": 20, "30735": 20, "029": 20, "01021": 20, "39129": 20, "44069": 20, "05216": 20, "57": [20, 67, 76, 81, 90, 100, 101, 120, 122, 143, 156], "05217": 20, "000009": [20, 81], "000008": 20, "000020": [20, 120], "000203": 20, "000517": 20, "000204": 20, "086880553": 20, "087620796": 20, "087643410": 20, "087643431": 20, "087643830": 20, "087643871": 20, "087643878": 20, "0876438777327964": 20, "95315": 20, "04685": 20, "953": [20, 144], "28914": 20, "047": 20, "05684": 20, "59": [20, 24, 101, 120, 122, 124, 131, 143, 148, 156], "42504": 20, "43766": 20, "04502": 20, "10184": 20, "000014": 20, "000064": 20, "000028": 20, "000070": 20, "073560812": 20, "073683015": 20, "073686144": 20, "073686146": 20, "073686198": 20, "0736861977839984": 20, "94069": 20, "05931": 20, "941": 20, "28139": 20, "059": [20, 67], "08157": 20, "43712": 20, "81": [20, 44, 60, 62, 70, 76, 89, 120, 131, 143, 156], "43979": 20, "89": [20, 76, 98, 101, 143, 156], "00945": 20, "12654": 20, "64": [20, 62, 65, 76, 89, 90, 100, 101, 120, 124, 125, 143, 144, 148, 156], "000011": 20, "000027": 20, "060834921": 20, "060927904": 20, "060929937": 20, "060929939": 20, "060929976": 20, "0609299759850992": 20, "92513": 20, "07487": 20, "925": [20, 150], "27431": 20, "075": 20, "10202": 20, "43772": 20, "45146": 20, "99641": 20, "14891": 20, "049377798": 20, "049448418": 20, "049449776": 20, "049449777": 20, "049449803": 20, "0494498033566835": 20, "90585": 20, "09415": 20, "906": 20, "26777": 20, "094": 20, "11880": 20, "43938": 20, "45872": 20, "00427": [20, 75], "16807": 20, "022299527": 20, "022652787": 20, "022659725": 20, "022659729": 20, "022659836": 20, "0226598364942836": 20, "81873": 20, "18127": 20, "819": [20, 83, 113, 156], "25002": 20, "181": 20, "15227": 20, "45080": 20, "45534": 20, "10024": 20, "20552": 20, "000023": [20, 81], "000026": 20, "999662902": 20, "999866062": 20, "999867885": 20, "999867891": 20, "999867909": 20, "9998679085818645": 20, "55489": 20, "44511": 20, "555": 20, "22008": 20, "445": 20, "16990": 20, "42907": 20, "48629": 20, "22325": 20, "23230": 20, "000016": 20, "000040": 20, "993557101": 20, "993586946": 20, "993587298": 20, "993587300": 20, "993587315": 20, "9935873149617622": 20, "27419": 20, "72581": 20, "274": [20, 100], "19023": 20, "726": 20, "16441": 20, "42499": 20, "51450": 20, "25237": 20, "992627083": 20, "992651090": 20, "992652443": 20, "992652516": 20, "992652518": 20, "992652519": 20, "9926525186787301": 20, "05363": 20, "94637": 20, "054": [20, 70, 150], "15719": 20, "946": 20, "15112": 20, "45665": 20, "50852": 20, "27565": 20, "27566": 20, "denomin": [21, 22, 33, 82, 117, 143], "scame": 21, "few": [21, 35, 42, 46, 47, 52, 53, 69, 72, 73, 91, 102, 106, 125, 128, 143, 144, 149], "cheaper": 21, "dramat": [21, 90], "qualit": [21, 121], "homolyt": [21, 120], "oh": [21, 33, 52, 130, 133], "8957": 21, "3167": 21, "e_oh_hf": 21, "e_oh_fci": 21, "ohdist": [21, 33, 52], "200": [21, 58, 75, 90, 100, 131, 132, 133, 137, 139], "get_natural_occup": [21, 24, 120], "explan": [21, 23], "increasingli": [21, 82, 148], "highest": [21, 31, 64, 72, 96, 126, 143, 144], "sigma_star": 21, "noni": 21, "9999994": 21, "99931502": 21, "9986904": 21, "97454512": 21, "00019271": 21, "99980729": 21, "02745005": 21, "casci": [21, 90], "major": [21, 76], "flaw": 21, "behind": [21, 43, 52, 64, 144], "tempt": 21, "relax": [21, 43, 46, 57, 58, 59, 64, 69, 90, 96, 123, 128, 141, 142, 144, 148, 149], "enough": [21, 51, 60, 71, 89], "e_casscf": 21, "zz": [21, 38, 61, 76, 82, 83, 84, 89, 131, 144], "did": [21, 46, 60, 144], "zone": 21, "again": [21, 33, 46, 47, 61, 72, 82, 142, 143], "difficulti": [21, 46, 47, 49, 90, 98, 120, 143, 149], "essenti": [21, 59, 69, 71, 75, 82, 106], "homo": [21, 72, 86, 90, 96, 102, 105, 113, 124, 125, 126, 137, 142, 153, 157], "lumo": [21, 72, 86, 102, 105, 113, 124, 125, 126, 142, 144, 148, 153, 157], "lone": [21, 90, 92, 101, 124], "request": [21, 72, 76, 89, 94, 98, 124, 133], "geometri": [21, 33, 43, 45, 46, 47, 53, 59, 60, 62, 64, 65, 66, 67, 100, 130, 132, 133, 137, 155], "easier": [21, 84, 142], "hope": [21, 101, 150], "stabl": [21, 43, 44, 83, 92, 122, 143, 144], "similarli": [21, 43, 45, 80, 84, 86, 89, 117, 124], "stronger": [21, 143], "reorder": [21, 38, 106, 113, 148], "recommend": [21, 42, 123, 141, 143, 145, 148, 157], "borrow": 21, "kappa": [21, 33, 38, 49, 61, 70, 86, 88, 90, 96, 97, 111], "kappa_": [21, 38, 86, 88, 90, 97, 111], "qp": [21, 24, 33, 38, 46, 72], "neglect": [21, 33, 46, 55, 72, 80, 90, 101, 106, 144], "hessian": [21, 43, 45, 46, 52, 57, 60, 61, 64, 65, 88, 106, 111, 115, 129, 130, 132, 148, 156], "sum_r": 21, "pr": [21, 24], "rq": 21, "rst": 21, "gamma_": [21, 33, 46, 70, 72, 75, 76, 83, 91, 130], "prst": 21, "st": [21, 46, 60, 67], "2h_": 21, "ss": [21, 22, 71, 72], "iq": [21, 46], "jj": [21, 25, 41], "qj": [21, 46, 49], "tq": 21, "sum_u": 21, "uq": [21, 46], "uj": 21, "uvw": 21, "vw": 21, "pj": [21, 49], "analog": [21, 25, 46, 49, 61, 72, 96, 111], "newton": [21, 55, 64], "rate": [21, 27, 55, 65, 117, 123], "displac": [21, 25, 45, 46, 50, 60, 65, 100, 130, 131, 132, 150, 156], "algorithm": [21, 32, 33, 46, 52, 55, 56, 60, 67, 70, 72, 100, 113, 153], "ia": [21, 22, 33, 38, 46, 49, 70, 72, 80, 86, 88, 94, 97, 106, 113], "aa": [21, 38, 67, 125, 143, 153], "ta": 21, "tt": 21, "moder": [21, 43, 71, 89, 90], "water_stretch": 21, "reus": [21, 33], "wrote": 21, "ci_integr": 21, "molspac": 21, "silent": 21, "outputstream": [21, 125, 145], "deactiv": [21, 122], "feed": [21, 47], "_update_integr": [21, 22], "dact": 21, "d2act": 21, "dact_pq": 21, "jact": 21, "kact": 21, "feff": 21, "qn": 21, "tn": 21, "fiq": 21, "pu": [21, 46, 67], "ftq": 21, "quvw": 21, "fpq": 21, "fqp": 21, "transpos": [21, 33], "diag1": 21, "qm": [21, 35, 39, 40, 51, 52, 55], "diag2": 21, "hess": [21, 149], "divis": [21, 105], "expx": 21, "expm": [21, 97, 99], "newmo": 21, "en": [21, 52, 81, 92], "newmolorb": 21, "molorb": 21, "88252747": 21, "25e": 21, "89753572": 21, "89903251": 21, "89930538": 21, "40e": [21, 72], "89938498": 21, "89941463": 21, "75e": [21, 72], "89942666": 21, "89943169": 21, "03e": 21, "89943383": 21, "89943474": 21, "33e": [21, 89], "89943514": 21, "84e": 21, "89943531": 21, "86e": 21, "89943538": 21, "89943542": 21, "58e": 21, "89943543": 21, "89943544": 21, "55e": [21, 72, 76], "truncat": [21, 32, 55, 72, 73, 100, 101, 118], "cluster": [21, 43, 46, 67, 68, 71, 72, 117, 128, 147, 149], "variant": 21, "mr": 21, "mrcisd": 21, "1141": 21, "55": [21, 67, 90, 99, 100, 101, 120, 124, 125, 143, 156], "31345": 21, "intern": [21, 31, 43, 56, 60, 67, 99, 111, 113, 123, 147], "harder": 21, "itua": 21, "ivwa": 21, "_u": 21, "_t": [21, 65], "_w": 21, "wors": [21, 33, 75, 101, 144], "trick": [21, 29, 122], "uncontract": 21, "superior": 21, "medium": [21, 67, 74, 89], "summari": [21, 65, 131], "mrmp2": 21, "caspt2": 21, "nevpt2": 21, "ic": [21, 46, 72], "ccsd": [21, 67, 128, 143, 149], "mk": [21, 34, 36, 41], "mrccsd": 21, "mrci_result": 21, "brillouin": [21, 75], "mrci": 21, "mrcis_result": 21, "04497247698047602": 21, "rspt": 22, "mp": [22, 43, 46, 145, 149], "hjo14": [22, 46, 67, 72], "sb09": [22, 67], "so12": [22, 46, 67, 72], "zeroth": [22, 33, 46, 70, 72, 73, 84, 88], "phi_n": [22, 27, 28], "cal": [22, 65, 76, 97, 98, 150], "phi_0": [22, 27], "master": [22, 72, 76, 89, 98, 148], "virt": [22, 86, 88, 96, 97, 113], "amplitud": [22, 43, 46, 65, 70, 72, 73, 88, 96, 97, 99, 111, 113, 117, 125, 130, 131, 132, 142, 143, 145, 150, 151, 153, 156], "jb": [22, 46, 70, 72, 80, 86, 106, 113], "ib": [22, 33, 46, 70, 72, 86, 106, 113, 144], "ja": [22, 25, 33, 46, 70, 72, 86], "nvirt": [22, 38, 86, 88, 94, 96, 106, 113, 115, 142], "ingredi": [22, 46, 52, 60, 70], "e_mp2_ss": [22, 33], "e_mp2_o": [22, 33], "subset": [22, 33, 70], "e_o": 22, "e_v": 22, "enegi": 22, "e_ijab": [22, 33], "15163083": 22, "05138187": 22, "20301270": 22, "compute_convent": [22, 144], "yet": [22, 144], "topic": [22, 43, 66, 143], "mp2_dimer_result": 22, "4060254140": 22, "4060254051": 22, "regardless": [22, 28, 65], "th": [22, 46, 70, 80, 144], "mpn": 22, "differenti": [22, 46, 49, 55, 61, 82, 84, 100], "npot_drv": [22, 25], "v_nucpot_ao": 22, "ai": [22, 25, 36, 39, 49, 72, 86, 88, 90, 97, 111, 143], "bj": [22, 25, 49, 86, 106, 113], "g_ao": 22, "h0": [22, 60, 81, 99], "v_1": 22, "v_2": 22, "third": [22, 34, 36, 41, 46, 47, 61, 67, 72, 76, 82, 88, 98, 115, 117, 120], "stencil": [22, 83], "lambda_v": 22, "e_mp2": [22, 33, 144], "12747116": 22, "12747066": 22, "commonli": [23, 32, 46, 47, 55, 70, 98, 104, 120], "versu": [23, 146], "strong": [23, 33, 47, 69, 74, 92, 96, 101, 105, 120, 121, 124, 128, 141, 142, 143, 149], "equiv": [24, 25, 27, 28, 84, 88, 97, 150], "dagger_p": [24, 70], "psi_q": [24, 28, 29], "nonzero": [24, 29, 82, 96, 102], "alpha_p": 24, "phi_q": [24, 28, 29, 46, 73], "beta_p": 24, "phi_p": [24, 26, 28, 29, 46, 73, 96], "NO": [24, 67, 120], "pp": [24, 33], "sum_q": 24, "u_": [24, 49, 97], "rohf": [24, 121, 122], "unoccuppi": 24, "rohf_drv": 24, "scfrestrictedopendriv": [24, 122], "rohf_result": 24, "149": [24, 67, 122, 142], "60946112": [24, 122], "nine": [24, 122], "print_orbit": [24, 122], "09511": 24, "73155": 24, "46": [24, 62, 67, 90, 101, 120, 122, 124, 125, 143, 148, 156], "70486": 24, "2p0": [24, 90, 101, 120, 122, 124, 125, 143, 148], "20397": 24, "47356": 24, "08237": 24, "33": [24, 70, 75, 90, 91, 98, 100, 101, 120, 122, 125, 143, 156], "10988": 24, "sigma_u": 24, "pi_g": 24, "p_": [24, 49, 82, 91], "pi_u": 24, "sigma_g": [24, 122], "casscf_drv": 24, "orbital_spac": 24, "casscf_result": 24, "70836718": 24, "predominantli": [24, 82], "civec": [24, 75, 122], "972": 24, "945": 24, "155": [24, 125], "024": [24, 26, 90, 101, 124], "iii": [24, 39, 67], "iv": 24, "96299851": 24, "96098176": 24, "03637598": 24, "04026925": 24, "beta_q": 24, "sum_p": [24, 96], "uhf_drv": 24, "uhf_result": 24, "udft": [24, 122], "62899231": 24, "n_alpha_electron": 24, "n_beta_electron": 24, "s_ab": 24, "occ_numb": 24, "orb": [24, 90, 124], "999": [24, 83, 90, 101, 122], "997": [24, 150], "994": [24, 26, 101], "natural_orbit": [24, 122], "natural_orb": [24, 122], "34641": 24, "09919": 24, "70203": 24, "20095": 24, "21925": 24, "65627": 24, "1d": [24, 26, 88, 100, 120, 122, 143], "001": [24, 26, 41, 46, 47, 70, 83, 99, 100, 101, 106, 113, 122, 148], "07548": 24, "1d0": [24, 120, 143], "freedom": [25, 26, 45, 52, 66, 129], "furthermor": [25, 40, 45, 47, 49, 62, 72, 82, 84, 143, 144, 148, 149], "psi_p": [25, 28, 29, 97], "elementari": [25, 82, 150], "pertin": 25, "12pt": [25, 28], "aj": [25, 36, 41, 46, 106, 113], "ba": [25, 33, 38, 46, 81, 86, 99, 122], "psi_c": [25, 146, 150], "psi_d": [25, 150], "phi_a": [25, 94, 96, 150], "phi_b": [25, 86, 150], "phi_c": [25, 144, 150], "phi_d": [25, 150], "quatum": 25, "govern": 25, "m_a": [25, 100], "2_a": 25, "magnitud": [25, 33, 41, 74, 82, 96, 99, 111, 129, 144], "mass": [25, 55, 78, 89, 91, 100, 150, 156], "1800": [25, 156], "1836": [25, 156], "veloc": [25, 74, 75, 78, 81, 89, 90, 91, 101, 124, 148, 150], "decoupl": [25, 46, 69, 82], "eigenst": [25, 27, 31, 100, 104, 106, 124, 130, 141, 142, 143, 144, 145, 151, 153], "2_i": 25, "z_a": [25, 36, 38, 39, 83], "z_b": 25, "brief": 25, "rep": 25, "v_k": 25, "parametr": [25, 46, 47, 67, 90], "rovibron": [25, 103], "phi_k": 25, "phi_": [25, 29, 31, 36, 40, 46, 72, 96, 100], "rangle_k": 25, "71500000": [25, 26], "e_nuc": 25, "e_tot": [25, 143, 145], "e_elec": 25, "762591694646": 25, "130": [25, 62, 156], "366128020400": 25, "112": [25, 26, 67, 156], "603536325754": 25, "occpui": 25, "v_ao": 25, "h_aver": 25, "188": [25, 100, 150], "97928532728588": 25, "oooo": 25, "g_oooo": 25, "chem_oooo": 25, "g_aver": 25, "iijj": 25, "ijji": [25, 29], "61315730688548": 25, "resid": 26, "hilbert": 26, "mathcal": [26, 27, 30, 31, 33, 38, 46, 49, 55, 91, 117], "spinor": [26, 31], "center": [26, 38, 46, 58, 66, 67, 82, 84, 143], "compactli": 26, "momentum": [26, 31, 76, 78, 89, 91, 98, 100, 128, 150], "2py": [26, 38], "2pz": [26, 38], "2px": [26, 38], "091": [26, 120], "228": 26, "109": [26, 100, 150, 156], "105": [26, 67, 90, 142, 143, 156], "004": [26, 70], "836": 26, "536": [26, 67, 144, 145], "231": 26, "114": [26, 67, 125, 156], "089": 26, "023": [26, 70, 90, 101, 124, 125], "856": 26, "526": [26, 67], "196": 26, "547": [26, 70], "028": [26, 70, 101], "056": 26, "845": 26, "541": [26, 90, 144], "621": 26, "942": [26, 156], "002": 26, "578": [26, 113], "852": 26, "248": 26, "017": [26, 120], "031": 26, "022": [26, 70, 125], "255": 26, "251": 26, "337": 26, "132": [26, 27, 38, 67, 76, 113, 120, 156], "285": [26, 67, 142], "get_avail_basi": 26, "suppli": [26, 94, 134], "directori": [26, 42], "3df": 26, "3pd": 26, "2df": 26, "2pd": 26, "ano": [26, 38], "mb": 26, "vdzp": 26, "vqzp": 26, "vtzp": 26, "pcv5z": 26, "pcvdz": [26, 143, 149], "pcvqz": [26, 143], "pcvtz": [26, 143, 144, 149], "pv5z": 26, "pv6z": 26, "pvqz": [26, 143], "pcseg": 26, "pcx": 26, "daug": [26, 78], "qzvp": 26, "qzvpd": 26, "qzvpp": 26, "qzvppd": 26, "sv": [26, 120], "svp": [26, 81, 88, 96], "tzvp": 26, "tzvpd": 26, "tzvpp": 26, "tzvppd": 26, "sadlej": [26, 98], "6g": 26, "taug": 26, "tabl": [26, 91, 102, 113, 124, 143, 144, 149], "2s1p": 26, "3s2p": 26, "tripl": [26, 75, 128, 133], "4s3p": 26, "momenta": 26, "3s2p1d": 26, "diffus": [26, 43, 78, 89, 98, 128, 143, 145, 148, 149], "expon": [26, 52, 146], "4s3p2d": 26, "get_dimensions_of_primitive_basi": 26, "nprim": 26, "get_label": [26, 34, 36, 39, 41, 83, 130, 131, 132, 156], "divid": [27, 33, 46, 70, 80, 82, 129], "pertub": 27, "undetermin": [27, 46], "unperturb": [27, 46, 49], "customiz": 27, "setup_system": 27, "energy_separ": 27, "verbos": [27, 70, 72], "h_0_diag": 27, "seed": [27, 97], "20220526": 27, "eigval": [27, 81], "e_exact": 27, "m_diag": 27, "4931": 27, "1577": [27, 156], "9948": 27, "2499": 27, "0431": [27, 153, 156], "4836": 27, "1796": 27, "2426": 27, "9848": 27, "1341": [27, 156], "2125": [27, 156], "4843": 27, "2393": 27, "0742": [27, 156], "9982": 27, "1831": 27, "0795": [27, 156], "492": [27, 144], "2116": 27, "2425": 27, "9965": 27, "1532": [27, 156], "0945": [27, 156], "4865": 27, "2328": [27, 156], "9925": 27, "rspt_solver": 27, "50000000": 27, "03590812": 27, "49306122": 27, "02896934": 27, "46820039": 27, "00410850": 27, "46796433": 27, "00387245": 27, "46420937": 27, "00011749": 27, "46437373": 27, "00028185": 27, "46401910": 27, "00007279": 27, "46407353": 27, "00001836": 27, "46407816": 27, "00001372": 27, "46408390": 27, "00000798": 27, "critic": [27, 67, 78, 82], "noninteract": 27, "straightforwardli": [27, 38, 82, 102], "parenthesi": [27, 72], "sum_n": [28, 90], "formula": [28, 46, 49, 67, 75, 99, 101], "70000000": 28, "infinitesim": [28, 30], "consequ": [28, 29, 38, 40, 41, 74, 97, 102, 132], "d_mo": 28, "d_ao": 28, "half": [28, 73, 130, 143], "intersect": [28, 123, 124, 143], "bohr": [28, 100, 150, 157], "2000": [28, 156], "one_part_den": 28, "lw": [28, 47, 99], "ko": [28, 113], "panel": [28, 72, 124, 144], "enlarg": 28, "cusp": [28, 47], "_3": [28, 38, 91, 123, 132, 133, 142, 143, 144], "psi_r": [28, 29, 97], "get_two_particle_dens": 28, "two_part_den_aa": 28, "two_part_den_ab": 28, "figtext": 28, "hole": [28, 67, 69, 71, 72, 73, 94, 105, 141, 144, 145, 147, 148, 153], "k_1": [29, 150], "k_p": [29, 150], "k_m": [29, 150], "prod_": [29, 97], "m_p": 29, "sub": [29, 38, 113, 129], "oplu": 29, "vacuum": [29, 39, 89, 150], "vac": [29, 97], "0_1": 29, "0_2": 29, "0_m": 29, "destroi": 29, "k_2": 29, "1_p": 29, "0_p": 29, "popul": [29, 92, 122, 143, 145], "destruct": [29, 144], "dagger_": [29, 38, 97], "i_1": [29, 82], "i_2": [29, 82], "i_n": [29, 82], "leftrightarrow": [29, 30, 46], "i_p": 29, "lost": 29, "presum": 29, "occupationnumbervector": 29, "occ_orb": 29, "occ_num_vec": 29, "dtype": [29, 86, 88, 97, 99], "__mul__": 29, "array_equ": 29, "inner_prod": 29, "els": [29, 52, 60, 86, 136, 143], "__str__": 29, "noccup": 29, "prod": 29, "seri": [29, 33, 55, 68, 70, 72, 73, 76, 89, 100, 108, 128, 143], "dagger_i": [29, 86, 90], "ket": [29, 46, 70, 72, 73], "bra": [29, 46, 70, 72, 73], "denisti": 29, "_r": [29, 70, 73, 97], "g_": [29, 38, 46, 49, 65, 91], "phi_r": [29, 46, 97], "sigma_p": 29, "sigma_q": 29, "sigma_r": 29, "kroneck": [29, 46, 72], "ri": [29, 38], "pqii": 29, "iqri": 29, "jjii": 29, "obei": [30, 91], "permut": [30, 72, 82, 98, 143], "span": [30, 49, 144], "distinct": [30, 47, 49, 72, 99, 111, 120], "inhomogen": [31, 67, 151], "speak": [31, 43, 103], "pauli": 31, "_x": [31, 45, 52, 82, 88, 102], "_y": [31, 82, 102], "cyclic": [31, 33], "civita": 31, "2p_": 31, "fine": [31, 46, 100, 123, 129, 144, 150], "m_j": [31, 55, 66], "r_": [31, 36, 38, 39, 41, 47, 49, 84, 90, 91, 100, 150], "spheric": [31, 74, 84], "harmon": [31, 50, 52, 55, 65, 76, 82, 91, 98, 100, 132, 156], "regular": 31, "y_1": 31, "meshgrid": [31, 60], "arctan": 31, "exp": [31, 38, 60, 65, 70, 130, 131, 132, 151, 156], "fig1": 31, "h1": [31, 52], "frame_on": 31, "quiver": 31, "pivot": 31, "mid": [31, 84, 91, 117, 150], "ytick": [31, 113], "q2": 31, "doublet": 31, "unabl": 31, "s_1": 31, "t_1": [31, 38], "remind": 33, "den1": 33, "dm": [33, 46, 153], "nstate": [33, 72, 75, 81, 94, 101, 102, 105, 106, 113, 115, 122, 124, 144, 148, 151, 153], "hint": 33, "idx": [33, 88, 106, 113, 148], "argsort": [33, 106, 113, 148], "yourself": [33, 43], "warn": [33, 92, 148, 153], "omp_num_thread": [33, 92, 148, 153], "895700000000": [33, 52], "316700000000": [33, 52], "100000000000": [33, 52], "n_mo": [33, 144], "n_o": [33, 70], "n_v": [33, 70], "epsilon_a": [33, 46, 70, 72, 106, 113], "epsilon_i": [33, 46, 70, 72, 106, 113], "epsilon_ov": 33, "c_occ": 33, "c_vir": 33, "moeridrv": [33, 70], "eri_oovv": 33, "moints_nam": [33, 70], "chem_oovv": [33, 70, 86], "eri_ooov": 33, "chem_ooov": 33, "eri_ovvv": 33, "chem_ovvv": 33, "valid": [33, 46, 47, 67, 89, 91, 133, 149], "varepsilon_b": [33, 72], "varepsilon_j": [33, 72], "varepsilon_p": [33, 72], "get_mp2_correct": 33, "sc_fdrv": 33, "oovv": [33, 70, 86], "e_ij": 33, "e_ab": [33, 70], "algebra": [33, 43, 67, 73, 97, 118, 128, 149], "e_occ": [33, 70], "e_vir": [33, 70], "epsilon_b": [33, 46, 70, 72], "e_mp2_vlx": 33, "ncomparison": 33, "nativ": 33, "292550395109": 33, "208104435264": 33, "surviv": [33, 80, 91], "get_t_amplitud": [33, 70], "t_aaaa": [33, 70], "t_abab": [33, 70], "t_abba": [33, 70], "t_bbbb": [33, 70], "t_baba": [33, 70], "t_baab": [33, 70], "t2_aaaa": [33, 70], "t2_abab": [33, 70], "t2_abba": [33, 70], "t2_mp2": [33, 70], "aaaa": [33, 70], "abab": [33, 70], "abba": [33, 70], "frac14": [33, 70, 72], "care": [33, 46, 55, 60, 98, 100, 124, 128, 142, 143, 144, 148, 149], "t2": [33, 70], "ijba": 33, "overestim": [33, 41, 128, 143, 144], "templat": 33, "scf_drv_pec": 33, "disabl": 33, "printout": 33, "character": [33, 46, 60, 64, 65, 69, 74, 82, 84, 89, 91, 98, 130], "energet": [33, 65, 143], "analyt": [33, 43, 48, 50, 55, 60, 61, 66, 67, 83, 84, 89, 91, 96, 130], "mu_": [33, 38, 39, 46, 49, 61, 70, 75, 82, 83, 84, 91, 99, 100], "latin": 33, "greek": [33, 46], "firstorderproperti": [33, 131], "scf_densiti": 33, "prop": 33, "firstorderprop": [33, 131], "hf_dipole_mo": 33, "get_properti": [33, 131, 142], "print_properti": 33, "646957": 33, "644400": 33, "788215": 33, "170427": 33, "831723": 33, "281016": 33, "frac12": [33, 46, 49, 61, 72], "kab": 33, "ikab": [33, 46], "jkab": [33, 46, 72], "ijc": 33, "ijac": [33, 46], "ijbc": [33, 46, 72], "gamma_ij": 33, "vir": [33, 70], "gamma_ab": 33, "gamma_ao": 33, "unrelaxed_dens": 33, "ur_mp2_dipole_mo": 33, "295983": 33, "752313": 33, "563049": 33, "139860": 33, "570917": 33, "159859": 33, "respons": [33, 40, 43, 46, 49, 61, 67, 74, 78, 83, 93, 96, 100, 103, 104, 108, 113, 117, 118, 124, 131, 142, 143, 144, 148], "lambda_": [33, 38, 46, 94, 113], "bigg": [33, 49, 61, 66], "jkb": [33, 72], "jbc": [33, 72], "bc": [33, 38, 46, 72, 144], "varepsilon_c": 33, "cb": [33, 136], "varepsilon_k": 33, "term1": 33, "jacb": 33, "term2": 33, "lambda_ov": 33, "lambda_ao": 33, "rel_mp2_dipole_mo": 33, "jkib": 33, "kjib": 33, "jabc": 33, "385919": 33, "980908": 33, "242851": 33, "867744": 33, "254768": 33, "898034": 33, "strength": [33, 41, 43, 46, 55, 70, 72, 74, 75, 76, 83, 89, 90, 96, 98, 100, 101, 106, 111, 113, 117, 124, 143, 144, 148, 151], "scf_drv_p": 33, "method_dict_p": 33, "electric_field": [33, 83, 96], "00001": [33, 81, 120], "hf_e_p": 33, "mp2_e_p": 33, "field_strength": [33, 83, 96], "hf_mu_z": 33, "mp2_mu_z": 33, "scf_drv_m": 33, "method_dict_m": 33, "hf_e_m": 33, "mp2_e_m": 33, "5f": [33, 70, 75, 81, 83, 113, 124, 137, 144, 150, 151], "78821": 33, "36478": 33, "56305": 33, "24285": 33, "09314": 33, "16276": 33, "09078": 33, "83863": 33, "isom": 33, "16263": 33, "72155": 33, "08733": 33, "825": [33, 120], "metal": [33, 120, 147, 149], "worst": [33, 149], "scenario": 33, "merz": [34, 36, 41, 67], "kollman": [34, 36, 41, 67], "dens": [34, 43, 144], "exclus": 34, "bw90": [34, 67], "electrostat": [34, 35, 36, 39, 40, 41, 67], "methanol": [34, 36, 41, 125, 133, 137, 139], "methanol_xyz": [34, 36, 41, 133, 137], "2001": [34, 36, 41, 67], "0363": [34, 36, 41, 156], "8431": [34, 36, 41], "7031": [34, 36, 41], "0083": [34, 36, 41, 156], "1305": [34, 36, 41], "9877": [34, 36, 41], "8943": [34, 36, 41], "7114": [34, 36, 41], "0155": [34, 36, 41, 156], "8918": [34, 36, 41], "6742": [34, 36, 41], "6582": [34, 36, 41], "0067": [34, 36, 41, 156], "1730": [34, 36, 41, 156], "1326": [34, 36, 41, 156], "0311": [34, 36, 41, 81, 156], "6482": [34, 36, 41, 59], "respchargesdriv": [34, 36, 41], "esp_drv": [34, 36], "grid_typ": 34, "equal_charg": [34, 36, 41], "chelpg_charg": 34, "esp": [34, 37, 41], "conform": [34, 36, 41, 45, 47, 60, 67, 133], "margin": [34, 100], "5890": [34, 156], "003200": 34, "225480": 34, "611345": 34, "376265": 34, "fit": [34, 36, 41, 43, 100, 142], "root": [34, 36, 41, 75, 94, 101, 124], "186800": 34, "1990": [34, 67, 156], "361": [34, 67], "373": [34, 67], "zip": [34, 36, 41, 60, 70, 81, 100, 102, 105, 130, 131, 132, 156], "methyl": [34, 36, 41], "mm": [35, 36, 39, 40, 47, 62], "multiscal": [35, 53], "nobel": [35, 53], "prize": [35, 53], "2013": [35, 53, 156], "thousand": [35, 53], "induct": [35, 74, 91], "subsequ": [35, 66, 71, 103, 141], "goal": [36, 43, 143], "textbf": [36, 144], "q_a": [36, 38, 39, 41, 52], "bmk90": [36, 67], "sk84": [36, 67], "solvent": [36, 39, 53], "surfac": [36, 45, 47, 50, 51, 56, 57, 60, 62, 64, 67, 92, 123], "sum_a": [36, 38, 52, 90, 144], "1m": 36, "m1": 36, "q_1": [36, 45], "q_m": 36, "b_1": 36, "b_m": 36, "b_i": 36, "esp_charg": 36, "resp": [36, 37, 47, 62, 67], "420": [36, 41], "023220": 36, "148458": 36, "594785": 36, "376669": 36, "180034": 36, "1984": [36, 67, 156], "129": [36, 67, 76, 156], "chelpg": 37, "loprop": 37, "localis": 38, "glkarlstrom04": [38, 67], "meaning": [38, 43, 132], "suit": [38, 68, 82, 144], "fluorid": 38, "1733": 38, "5597": 38, "natom": [38, 81], "loprop_drv": 38, "lopropdriv": 38, "loprop_out": 38, "localized_charg": 38, "nlocal": 38, "xx": [38, 61, 82, 84, 88, 89, 131, 142, 144], "yy": [38, 61, 82, 84, 89, 131, 142, 144], "localized_polariz": 38, "1191": [38, 156], "4371": 38, "917": 38, "226": [38, 83], "9525": 38, "_4": [38, 132, 136, 139, 143], "orthonormalis": 38, "orthonomalis": 38, "aim": [38, 43, 65, 128, 149], "2443": 38, "1716": [38, 156], "0341": [38, 156], "0601": [38, 156], "7635": [38, 59], "2275": 38, "3321": 38, "4306": 38, "6374": 38, "6583": 38, "2409": 38, "5971": 38, "1098": [38, 156], "4105": [38, 156], "4995": 38, "re": [38, 46, 67, 91, 131, 143], "florid": 38, "1py": 38, "1pz": 38, "1px": 38, "t_0": [38, 55, 82, 99, 108], "rearranged_indic": 38, "angmom": 38, "get_basis_function_indices_for_atom": 38, "concaten": 38, "col": 38, "s0": 38, "choleski": 38, "intact": 38, "s_0": 38, "triangular": 38, "norb_per_atom": 38, "indices_occ": 38, "indices_virt": 38, "get_ao_indic": 38, "rf": 38, "s1": [38, 72, 81, 148], "0501": [38, 156], "2372": [38, 156], "3975": 38, "4416": 38, "0647": [38, 156], "5504": 38, "0641": [38, 156], "s1_oo": 38, "t2_oo": 38, "lowdin_orthonorm": 38, "s1_vv": 38, "t2_vv": 38, "s2": [38, 72, 81, 106, 113, 148], "0209": [38, 156], "0121": [38, 125, 153, 156], "0573": [38, 156], "1143": [38, 156], "0765": [38, 156], "2767": [38, 156], "0414": [38, 156], "4636": 38, "0698": [38, 156], "0505": [38, 156], "5822": 38, "1497": [38, 81, 156], "occipi": 38, "orthonormalizaton": 38, "s2_ov": 38, "index_occ": 38, "index_virt": 38, "s3": [38, 72, 81, 148], "7698": 38, "2818": [38, 156], "1001": [38, 156], "6502": 38, "1055": [38, 156], "8952": 38, "orthonmalis": 38, "s3_vv": 38, "t4_vv": 38, "index_virt1": 38, "index_virt2": 38, "s4": [38, 72, 81], "ef": 38, "af": 38, "9997": [38, 59], "2541": 38, "0022": [38, 156], "0123": [38, 156], "0032": [38, 156], "0527": [38, 156], "0229": [38, 156], "1253": [38, 156], "0183": [38, 125, 156], "1215": [38, 156], "1295": [38, 156], "045": 38, "0033": [38, 59, 156], "0222": [38, 156], "0237": [38, 156], "expctat": 38, "decomposit": [38, 94, 125], "atomic_properti": 38, "omega_ab": 38, "omega_l": 38, "d_l": 38, "dc": [38, 76, 98], "idx_a": 38, "idx_b": 38, "elem_ids_to_numpi": 38, "mu_ab": 38, "nmu_ab": 38, "9033": 38, "0947": [38, 156], "1471": 38, "4855": 38, "midpoint": 38, "get_coordin": [38, 47, 52, 65, 130, 131, 132, 156], "gaug": [38, 78, 90, 124], "orgin": 38, "5144": 38, "1116": [38, 156], "rangle_": [38, 76, 78, 82, 88, 89, 91, 98, 99, 113], "strucur": 38, "si": [38, 75, 76, 84, 91, 98, 101, 111, 124, 150], "lrs_drv": [38, 86, 113], "linearresponsesolv": [38, 78, 83, 86, 88, 89, 96, 106, 113, 131, 148], "lrs_out": [38, 113], "response_funct": [38, 78, 83, 86, 88, 89, 113, 124, 131, 142, 144], "8695": 38, "unpack": 38, "vec2mat": 38, "orign": 38, "exress": 38, "solution_z_0": 38, "get_full_solution_vector": [38, 94, 113, 142], "d1": [38, 83], "alpha_ab": 38, "nalpha_ab": 38, "869484": 38, "6304": 38, "2307": 38, "7776": 38, "dq_a": 38, "5231": 38, "3664": 38, "4019": [38, 59], "auxiliari": 38, "q_": [38, 39, 45, 84], "although": [38, 76, 90, 98, 142, 143, 144, 147], "lambda_a": 38, "penatli": 38, "r_a": [38, 39, 52, 83], "r_b": 38, "bragg": 38, "radii": 38, "bohr2ang": 38, "529177249": [38, 143], "dr_ab": 38, "l_": [38, 66, 82, 141, 143], "net": [38, 69, 74], "onc": [38, 46, 49, 55, 61, 65, 82, 100, 144], "l_ab": 38, "2963": [38, 156], "dq_ab": 38, "alpha_bond_ab": 38, "6396": 38, "sum_b": [38, 144], "alpha_a": 38, "tetrahedr": 39, "donor": 39, "acceptor": 39, "6891400000": 39, "8324710000": 39, "7224340000": 39, "8726890000": 39, "solvent_xyz": 39, "0991810000": 39, "2167050000": 39, "2791250000": 39, "2673500000": 39, "2529740000": 39, "6013580000": 39, "9984050000": 39, "8080510000": 39, "5840690000": 39, "8223690000": 39, "2141140000": 39, "3767710000": 39, "5990410000": 39, "8408210000": 39, "6698860000": 39, "4683410000": 39, "4151750000": 39, "5365150000": 39, "7377440000": 39, "0168380000": 39, "4861090000": 39, "0753880000": 39, "2446490000": 39, "3654140000": 39, "6636970000": 39, "7516570000": 39, "0543720000": 39, "0758700000": 39, "2692330000": 39, "5139440000": 39, "5822670000": 39, "1887880000": 39, "5058600000": 39, "1632420000": 39, "7082890000": 39, "8568430000": 39, "donors_xyz": 39, "acceptors_xyz": 39, "300": [39, 47, 59, 65, 70, 90, 92, 124, 130, 132, 133, 136, 137, 142, 154, 156, 157, 159], "setviewstyl": [39, 47, 59, 70, 90, 124, 130, 131, 132, 133, 136, 137, 139, 154, 156, 159], "style": [39, 47, 59, 70, 90, 124, 130, 131, 132, 133, 136, 137, 139, 154, 156, 159], "outlin": [39, 47, 59, 68, 70, 90, 124, 130, 131, 132, 133, 136, 137, 139, 154, 156, 159], "black": [39, 43, 47, 60, 99, 105, 124, 159], "probe": [39, 52, 67, 69, 74, 98, 117, 123, 128, 141, 142, 143, 144, 148, 149], "element_charg": [39, 83], "dipmom": [39, 83], "mu_e": [39, 83], "mu_n": [39, 83], "molecule_atom_label": [39, 83], "get_atom_coordin": [39, 83], "solver": [39, 43, 70, 76, 83, 89, 90, 98, 100, 113, 124, 125, 131, 148], "scf_solver": 39, "f_mo": 39, "c_hf": 39, "mu_hf": 39, "878333": 39, "tip3p": 39, "834": [39, 156], "417": [39, 90], "tip3p_charg": 39, "mu_tip3p": 39, "112794": 39, "get_embedding_oper": 39, "mm_site": 39, "mm_charg": 39, "atom_idx": 39, "atom_label": 39, "pot_drv": 39, "v_e": [39, 143], "v_n_e": 39, "solvent_atom_label": 39, "v_n_": 39, "v_n_d": 39, "v_d": 39, "e_d": 39, "c_d": 39, "v_n_a": 39, "v_a": [39, 52], "c_a": 39, "pentam": 39, "bi": [39, 46], "v_s_aver": 39, "08545956": 39, "00987780": 39, "07558176": 39, "destabil": 39, "stabil": 39, "benefici": 39, "diff": 39, "98692530": 39, "05504275": 39, "96958319": 39, "01734211": 39, "01370114": 39, "65101990": 39, "66472104": 39, "67779574": 39, "02542388": 39, "73647946": 39, "28894441": 39, "69798088": 39, "put": [39, 43, 47, 97, 144], "mu_d": 39, "mu_a": 39, "147602": 39, "006242": 39, "031627": 39, "pot": [39, 52], "pot_fil": 39, "potfil": 39, "05504276": 39, "q_i": [40, 45, 47, 52, 91], "perm": 40, "el": 40, "nuc": 40, "ind": [40, 81], "t_i": [40, 55], "crucial": 40, "spectroscop": [40, 43, 67, 88, 99, 111], "restrain": [41, 47], "bcck93": [41, 67], "ccbk95": [41, 67], "merit": [41, 99], "buri": 41, "2_": [41, 97], "interior": [41, 144], "hyperbol": 41, "penalti": 41, "rstr": 41, "q_j": [41, 47], "resp_drv": 41, "resp_charg": 41, "stage": [41, 103, 120, 143], "restraint": [41, 67], "0005": [41, 81, 125, 156], "075643": 41, "117258": 41, "013902": 41, "013047": 41, "639004": 41, "419154": 41, "139861": 41, "033747": 41, "118610": 41, "ye": [41, 100, 131, 132, 153], "203249": 41, "phy": [41, 67, 70, 76, 89, 98, 148], "1993": [41, 67, 156], "10269": [41, 67], "10280": [41, 67], "ga": [41, 67, 76, 142, 147, 150], "imit": 41, "aqueou": 41, "protein": [41, 52, 53, 67, 133], "manag": 42, "maco": 42, "linux": 42, "repositori": 42, "certifi": 42, "miniconda": 42, "pip": 42, "zlib": 42, "libmamba": 42, "blog": 42, "newer": 42, "agent": 42, "config": 42, "termin": 42, "anaconda": 42, "powershel": 42, "support": 42, "prompt": 42, "yml": 42, "folder": [42, 70, 105, 153], "asterisk": 42, "interf": 42, "servic": 42, "permiss": 42, "permit": 42, "readi": [42, 43], "web": 42, "browser": 42, "tree": 42, "unix": 42, "adcc": [42, 43, 106, 142, 143, 144, 145, 148], "xtb": [42, 52, 54, 58, 59, 137, 156], "echem_window": 42, "wsl": 42, "crash": 42, "runtim": 42, "caus": [42, 47, 55, 82], "die": 42, "di": [42, 146], "rerun": 42, "undocu": 42, "clone": 42, "git": 42, "com": [42, 66, 67], "kthpanor": 42, "doc": [42, 43], "navig": 42, "_build": 42, "welcom": 43, "platform": 43, "driven": [43, 67], "target": [43, 100, 101, 106, 144, 145, 148], "audienc": 43, "undergradu": 43, "student": 43, "background": [43, 47], "websit": 43, "tutori": [43, 52, 54, 120, 141, 143, 144, 149], "thing": [43, 52, 55, 88, 119, 120], "consult": [43, 133], "stand": [43, 46], "alon": [43, 105], "rais": [43, 60, 141], "curios": 43, "organ": [43, 67, 97], "spectra": [43, 67, 68, 69, 70, 78, 102, 104, 106, 109, 115, 123, 126, 129, 131, 132, 141, 143, 145, 146, 148, 149, 151, 153, 156], "intend": [43, 47], "insight": [43, 141, 142, 148], "matter": [43, 49, 70, 82, 103, 128, 133, 144], "varieti": [43, 74, 109], "affect": [43, 47, 126, 131, 133, 143, 151], "daunt": 43, "veteran": 43, "deeper": 43, "riddl": 43, "inconsist": 43, "challeng": [43, 45, 67, 104], "vagu": 43, "believ": 43, "human": [43, 53], "abstract": 43, "lectur": 43, "never": 43, "rebuild": 43, "dismantl": 43, "box": [43, 55], "seem": [43, 46], "cog": 43, "gear": 43, "addition": [43, 46, 69, 154], "concret": [43, 102, 105, 115], "peopl": 43, "team": [43, 54], "engag": 43, "effort": [43, 46], "overreach": 43, "scienc": [43, 67], "contemporari": 43, "futur": 43, "meet": [43, 99, 103], "eurohpc": 43, "multitud": 43, "coverag": 43, "3d": [43, 60, 152], "500": [43, 69, 70, 99, 100, 101, 122, 133, 139, 143, 150], "transpar": 43, "exposur": 43, "depth": [43, 47, 69], "analys": [43, 102, 126, 141, 153], "embed": [43, 52, 106, 141, 144], "synchron": 43, "experiment": [43, 47, 74, 76, 82, 89, 91, 98, 117, 122, 142, 143, 144, 148, 151], "partner": 43, "simd": 43, "notion": 43, "suprem": 43, "grant": 43, "opportun": [43, 72], "ago": 43, "manner": [43, 47, 61, 72, 88, 113, 117, 122, 123, 142, 143, 148, 149], "freeli": [43, 73, 82], "friendli": 43, "rlv": [43, 67], "nonlinear": [43, 71, 74, 76, 82, 89, 91, 98, 99], "highli": [43, 47, 91, 100, 143, 144], "hardwar": [43, 53], "infrastructur": 43, "job": 43, "schedul": 43, "rrh": [43, 67, 71, 143, 144], "propag": [43, 67, 68, 70, 72, 74, 82, 109, 118, 139, 143, 144], "Its": [43, 74], "diagrammat": [43, 67, 70, 73, 118, 128, 149], "adc": [43, 46, 67, 68, 69, 71, 73, 118, 123, 125, 126, 128, 141, 142, 143, 146, 148, 149, 153], "fashion": 43, "oscil": [43, 47, 55, 70, 72, 74, 75, 90, 91, 99, 100, 101, 106, 113, 124, 143, 144, 148, 151], "absorpt": [43, 67, 69, 73, 74, 82, 91, 100, 102, 103, 104, 106, 113, 123, 129, 130, 134, 141, 142, 143, 145, 146], "referec": 43, "pyscf": [43, 143, 144, 145, 148], "psi4": 43, "uv": [43, 70, 100, 102, 124, 129, 134], "vi": [43, 70, 100, 102, 124, 129, 134, 153, 157], "rai": [43, 67, 69, 70, 104, 106, 125, 129, 134, 142, 143, 145, 146, 149], "emiss": [43, 67, 91, 100, 103, 141, 142, 143, 145, 146, 148, 149], "variuo": 43, "releas": 43, "qc": 43, "aggreg": [43, 91, 102, 105], "multirefer": [43, 67, 128], "special": [43, 46, 49, 60, 64, 91, 98, 99, 117, 122], "io": 43, "intro": 43, "ue": 43, "tric": [43, 60], "deloc": [43, 60, 69, 105, 141, 142, 143, 144, 153], "dlc": [43, 60], "possibli": [43, 55], "vibrat": [43, 48, 61, 65, 67, 103, 123, 124, 130, 132, 141, 143, 144, 151, 155], "enegin": 43, "tight": [43, 59], "semi": [43, 59], "noncoval": [43, 67], "toolkit": 43, "free": [43, 54, 67, 88], "toolbox": 43, "nto": [43, 94, 105, 126, 153, 158], "smile": [44, 58, 59, 134, 136, 139, 140], "read_smil": [44, 58, 59, 133, 139], "oc": [44, 58, 59, 133], "atom_indic": [44, 58], "xtbdriver": [44, 58, 59, 136, 139, 156], "opt_drv": [44, 47, 58, 59], "optimizationdriv": [44, 47, 58, 59, 65, 131, 136, 139], "conformer_energi": 44, "conformer_structur": 44, "tran": [44, 65], "hocc": 44, "occc": [44, 58], "ccco": 44, "set_dihedral_in_degre": 44, "opt_result": [44, 58, 59], "opt_energi": [44, 59, 156], "final_geometri": [44, 58, 59, 136, 139], "idx_lowest_conform": 44, "lowest_conform": 44, "hartree_in_kcalpermol": [44, 58, 59], "dimension": [45, 67, 71, 83, 106, 143], "pe": [45, 47, 57, 60, 64, 65, 91, 147], "interplai": [45, 67], "elucid": 45, "explain": [45, 50, 64, 65, 72, 73, 90, 120, 143], "photo": [45, 64], "reaction": [45, 56, 64, 65, 67, 92, 120, 133, 148], "pathwai": [45, 73], "favor": 45, "dihedr": [45, 47, 52, 53, 58, 139], "pose": 45, "q_2": 45, "n_q": 45, "n_x": 45, "3n": [45, 49, 55, 66, 130, 136], "x_1": [45, 66], "x_2": [45, 66], "x_": [45, 46, 66, 70, 73, 91, 100], "wilson": [45, 52, 66, 67], "neal09": [45, 60, 67], "x_j": [45, 52, 66], "linearli": [45, 61, 74, 82, 96], "pf92": [45, 67], "ws16": [45, 66, 67], "x_k": 45, "ijk": 45, "confirm": [46, 72, 76, 91, 115], "magnetizabilit": 46, "nmr": 46, "epr": 46, "jen06": [46, 67], "greater": [46, 75, 101, 124], "x_0": [46, 49], "divided_differ": 46, "proport": [46, 55, 89, 102, 132, 144], "true_deriv": 46, "lim_": 46, "quotient": [46, 150], "symmetric_difference_quoti": 46, "2x_0": 46, "five_point_method": 46, "12x_0": 46, "debug": 46, "exhibit": [46, 74, 82, 142, 143, 144], "implicit": [46, 91, 133], "chain": 46, "lwk05": [46, 67], "reh15": [46, 67], "energy_functional_gener": 46, "hellmann": [46, 84], "feynman": [46, 67, 70, 73, 84], "hj88": [46, 67], "lev05": [46, 67], "surpris": 46, "variation": 46, "conundrum": 46, "phrase": 46, "lagrangian_gener": 46, "f_c": 46, "hf_energy_fct": 46, "1212": [46, 156], "hf_lagrangian": 46, "epsilon_p": 46, "uniti": 46, "partial_l": 46, "ehf_dm": 46, "partial_l_fin": 46, "braket": [46, 70, 72], "superscript": [46, 76, 91], "xi": [46, 76, 81, 91, 106, 124, 125, 142, 143, 144, 148, 151], "hpq": 46, "fockmatel": 46, "hf_gamma_ij": 46, "jl": [46, 72], "orbitalrspcond": 46, "programm": 46, "rd19": [46, 67], "orbitalrspcond_program": 46, "derivfock": 46, "qt": 46, "ui": 46, "epsilon_o": 46, "rt": [46, 65, 143], "ru": 46, "derivoverlap": 46, "epsilon_": [46, 91], "l_dm": 46, "orbrsp1": 46, "orbrsp2": 46, "epsilon_u": 46, "ut": 46, "tpqr": 46, "qr": 46, "qpsr": 46, "srpq": 46, "renam": 46, "epsilon_t": 46, "upqr": 46, "tp": [46, 143], "orbrspeq": 46, "omega_hf": 46, "omega_hf_oo": 46, "jpqr": 46, "ip": [46, 143], "klm": 46, "km": [46, 61, 130, 131, 156], "lm": 46, "hf_grad_fin": 46, "generaliz": 46, "breakdown": [46, 125], "invari": [46, 61], "safe": [46, 47, 90], "energy_functional_mp": 46, "mp2_energy_fct": 46, "mp2_tamplitud": 46, "epsilon_j": [46, 70, 72], "mp2_lagrangian": 46, "f_t": 46, "t_condit": 46, "amplitude_rsp_gener": 46, "t_cond_explicit": 46, "epsilon_c": [46, 72, 144, 146], "epsilon_d": [46, 72], "epsilon_k": [46, 72], "epsilon_l": [46, 72], "ampl_rsp_multipli": 46, "l_dms_mp": 46, "final_l_dms_mp": 46, "mp2_2pdm_oovv": 46, "ra_explicit": 46, "sum_c": 46, "ijcb": 46, "kjab": 46, "downarrow": [46, 74], "gammaa_ij": 46, "gammaa_ab": 46, "gammaa_ijab": 46, "mp2_gamma_ij": 46, "mp2_gamma_ab": 46, "mp2_gamma_ijkl": 46, "mp2_gamma_ijab": 46, "lambda_mp2_ov": 46, "pa": [46, 70], "apqr": 46, "ipqr": 46, "abjk": 46, "omega_mp2_oo": 46, "ka": [46, 72], "omega_mp2_ov": 46, "jkac": 46, "omega_mp2_vv": 46, "fhgp92": [46, 67], "tamm": [46, 80, 90, 94, 104], "dancoff": [46, 80, 90, 94, 104], "dhg05": [46, 67], "dw15": [46, 67, 68, 72, 73], "cis_eigenvalue_eq": 46, "omega_n": [46, 72, 82, 91], "excitation_energy_adc1": 46, "adc1_identify_dm": 46, "adc1_gamma_oo": 46, "adc1_gamma_vv": 46, "adc1_gamma_ovov": 46, "iajb": 46, "plug": 46, "reader": [46, 66, 72], "straightforwad": 46, "lambda_adc1_ov": 46, "jakb": 46, "kb": [46, 72, 76, 89, 98, 148], "ibkc": 46, "kc": [46, 72], "omega_adc1_oo": 46, "kajb": 46, "omega_adc1_ov": 46, "kajc": 46, "jc": [46, 72], "omega_adc1_vv": 46, "rpa": [46, 90, 94, 104, 106, 111, 124, 144, 146], "pseudo": [46, 106], "y_": [46, 72, 88, 94], "fa02": [46, 67], "sr": 46, "pqrstu": 46, "phi_t": 46, "phi_u": 46, "eventu": [46, 82, 111, 144], "tda": [46, 81, 90, 94, 104, 115, 144, 146], "hhg99": [46, 67], "magnetiz": [46, 91, 150], "hold": [46, 52, 78, 82, 98, 117, 143], "sign": [46, 74, 76, 82, 88, 89, 91, 96, 98, 120, 144, 157], "dipmom_explicit": 46, "unrelax": [46, 143], "proper": [46, 82, 90, 143], "hrdh19": [46, 67, 72], "oppenheim": [47, 55, 100], "util": 47, "respond": [47, 111], "instantli": 47, "unsurprisingli": 47, "trajectori": [47, 55, 60, 155, 156], "sacrif": 47, "nuanc": 47, "strip": 47, "awai": [47, 65, 143, 144, 149], "primarili": [47, 54, 102, 140, 143], "ethan": [47, 133, 136], "k_l": 47, "incap": 47, "distort": [47, 99, 111], "replic": 47, "sampl": [47, 67, 74, 76, 91, 98, 117, 133, 142, 144], "temperatu": 47, "hardli": 47, "mol_vlx": [47, 145], "bas_vlx": [47, 145], "bond_indx": 47, "2600": 47, "550": [47, 144], "addmodelsasfram": [47, 59, 62, 92, 154, 156], "bond_xyz": 47, "anim": [47, 59, 62, 65, 92, 130, 131, 132, 154, 156], "backandforth": [47, 62, 65, 130, 131, 132, 156], "harm_func": 47, "l0": [47, 81], "stiff": 47, "opt_harm1": 47, "025": [47, 60, 101, 124, 143], "i_min_d": 47, "i_max_d": 47, "opt_harm2": 47, "i_min_": 47, "i_max_": 47, "opt_harm3": 47, "spline": [47, 58, 124, 142, 144], "275": [47, 90], "symm": 47, "167": [47, 100], "9888": 47, "157": [47, 90, 136], "10094": 47, "158": [47, 90], "160": [47, 62, 100, 148], "unrealist": [47, 105], "steeper": 47, "mors": [47, 100], "d_e": 47, "theta_0": 47, "overli": 47, "simplist": 47, "angle_scan": 47, "hd5": 47, "pdb": [47, 154, 159], "txt": [47, 70, 131], "discard": [47, 80, 144], "water_mol_str": [47, 106, 124, 143, 144, 145, 148, 153, 157], "dirver": [47, 131], "grad_drv": [47, 52], "scfgradientdriv": [47, 52, 65, 131], "angle_a": 47, "angle_": 47, "angle_xyz": 47, "opt_molecul": 47, "angle_indx": 47, "vlx2py3d": 47, "outpyt": 47, "readabl": [47, 136], "b2a": 47, "5291772": 47, "backandfirth": 47, "i_min_a": 47, "i_max_a": 47, "opt_harm_angl": 47, "150": [47, 62, 67, 72, 76, 89, 98, 122, 148], "135": [47, 67, 156], "108": [47, 100, 156], "814": [47, 120], "126546": 47, "110": [47, 62, 67, 156], "compress": [47, 55, 143, 149], "steep": 47, "bigl": 47, "bigr": 47, "behaviour": [47, 55, 101, 142], "temperatur": [47, 55, 74, 76, 89, 100, 150], "central": [47, 150], "twist": [47, 102, 120], "fourth": [47, 76, 83, 88], "fourier": [47, 88, 99], "period": [47, 55, 67, 143, 149], "mm3": 47, "charmm": 47, "barrier": [47, 67, 92], "recreat": 47, "ethane_mol_str": 47, "7616375820": 47, "0145603421": 47, "1557300969": 47, "5072801711": 47, "8786350299": 47, "dihed_a": 47, "dihed_": 47, "dihed_xyz": 47, "dihedral_scan": 47, "1f77b4": 47, "600": [47, 59, 62, 101, 120, 131, 132, 133, 154, 156], "costli": [47, 53, 147], "md": [47, 53, 54, 55, 62, 155, 156], "cut": 47, "off": [47, 113, 115, 117, 124, 143, 144, 148, 149], "lennard": 47, "jone": [47, 74], "epsilon_0": [47, 61, 76, 89], "favour": 47, "deal": [47, 49, 55, 56, 69], "ionic": 47, "noindent": 47, "bottom": [47, 113], "pragmat": 47, "elong": [47, 120], "formaledehyd": 47, "hard": [47, 55, 128, 144, 149, 153], "aforement": [48, 82, 88], "resort": [49, 91], "y_0": 49, "anymor": 49, "previous": [49, 52, 84, 141, 143, 144, 149], "pksb79": [49, 67], "hf_gradient_in_ao": 49, "hf_hessian_popl": 49, "boil": 49, "rearrang": [49, 55, 74], "nee09": [49, 67], "derivative_hf_equ": 49, "ansatz": 49, "perturbed_mo_coeffici": 49, "sc": [49, 144], "subscript": [49, 66, 72], "derivative_fock_matrix": 49, "dfa02": [49, 67], "rh": 49, "arbitrari": [49, 50, 52, 60, 96, 144], "perturbed_dens": 49, "hf_hessian_furch": 49, "jq": 49, "proced": 49, "ir": [49, 66, 100, 129, 156], "mix": [49, 61, 76, 102, 122, 142, 144, 148, 149, 150], "disadvantag": [50, 60], "global": [51, 52, 55, 56, 134, 143, 144, 148], "fluoresc": [52, 123, 141, 144], "rp16": [52, 67], "w_a": 52, "beween": 52, "taylor": [52, 55, 100, 108, 111], "v_i": 52, "un": 52, "kr16": [52, 67], "shepard": 52, "2q": 52, "confid": 52, "overview": [52, 144], "molecule_str": [52, 130], "grad_result": 52, "hess_drv": 52, "scfhessiandriv": [52, 130, 131, 132], "hess_result": 52, "z_matrix": 52, "internal_coordin": 52, "elif": [52, 60, 70, 130, 131, 132, 156], "get_b_matrix": 52, "n_atom": 52, "n_cart": 52, "n_int": 52, "b_matrix": 52, "deriv_q": 52, "spot": [52, 82], "atom_index": 52, "b_mat": 52, "bb": [52, 143], "carefulli": [52, 128, 149], "g_mat": 52, "diagnoal": 52, "g_val": 52, "g_vec": 52, "eig": [52, 106, 113, 115, 148], "g_val_invers": 52, "g_val_inverse_mat": 52, "g_minu": 52, "get_g_minu": 52, "get_b2_matrix": 52, "b2_matrix": 52, "second_deriv_q": 52, "second_deriv": 52, "atom_index_a": 52, "atom_index_b": 52, "convert_gradient_to_intern": 52, "gradient_q": 52, "grad_x": 52, "grad_q": 52, "convert_hessian_to_intern": 52, "gradq_b2mat": 52, "ixi": 52, "hessian_q": 52, "convers": [52, 66, 70, 84, 86, 91, 123, 124, 125, 144, 145], "coordiant": 52, "cart_gradi": 52, "cart_hessian": 52, "new_molecul": 52, "new_scf_drv": 52, "new_scf_result": 52, "new_scf_grad_drv": 52, "new_scf_hessian_drv": 52, "n_data_pt": 52, "int_gradi": 52, "int_hessian": 52, "hess_x": 52, "b2_mat": 52, "hess_q": 52, "get_harmonic_potenti": 52, "g_a": 52, "h_a": [52, 80], "new_q": 52, "coords_a": 52, "get_internal_coordinates_arrai": 52, "cart_coord": 52, "q_list": 52, "molec": 52, "harmonic_potenti": 52, "get_interpolated_p": 52, "new_point": 52, "data_point": 52, "sum_weight": 52, "n_point": 52, "new_energi": 52, "im_energi": 52, "qm_point": 52, "dimgrei": 52, "im": [52, 91], "ymin": [52, 131, 156], "ymax": [52, 131, 156], "eg": 52, "unless": 53, "todai": 53, "newtonian": [53, 150], "emul": [53, 55, 148], "award": 53, "assembl": 53, "reparameter": 53, "ensembl": 53, "meantim": 54, "justin": 54, "lemkul": 54, "molssi": 54, "canada": 54, "gromac": 54, "openmm": [54, 62], "mdanalysi": 54, "mdtraj": 54, "kept": [55, 60, 143], "maintain": [55, 101], "accumul": 55, "drift": 55, "thermal": [55, 76], "heat": [55, 92], "bath": 55, "maxwel": 55, "boltzmann": [55, 89, 150], "rescal": 55, "criterion": 55, "berendsen": 55, "tau": [55, 105, 113, 150, 153], "reproduc": [55, 84, 89, 91, 149], "rightarrow": [55, 75, 76, 82, 89, 91, 92, 108, 113, 136, 142, 143, 144, 146], "infin": 55, "quick": [55, 60, 145], "equilibr": 55, "andersen": 55, "nos\u00e9": 55, "hoover": 55, "stochast": 55, "artifici": [55, 101], "pressur": [55, 74, 150], "regul": 55, "piston": 55, "nabla_j": 55, "jerk": 55, "hspace": 55, "1mm": 55, "THe": 55, "dealt": 55, "neither": [55, 72, 113], "nor": [55, 72, 113], "alter": [55, 105], "evid": [55, 91], "role": [56, 67, 74], "360": 58, "scan_energi": 58, "scan_geometri": 58, "e_min_in_au": [58, 59], "energy_scan": 58, "deepskyblu": 58, "shadow": 58, "loc": [58, 124, 142, 157], "set_titl": 58, "energies_in_kcalpermol": 59, "join": [59, 124, 142, 144], "opt_geometri": 59, "forward": [59, 92, 128, 149, 154, 156], "cafestol": 59, "kahweol": [59, 156], "robusta": 59, "arabica": 59, "coffe": 59, "bean": 59, "cafestol_xyz": 59, "5215": 59, "3455": 59, "4926": 59, "2905": 59, "0812": [59, 156], "7033": 59, "1630": [59, 156], "4345": 59, "1101": [59, 156], "2807": 59, "7511": 59, "0465": [59, 156], "5244": 59, "5810": [59, 65], "4102": 59, "9909": 59, "6610": 59, "0407": [59, 156], "9440": 59, "2916": 59, "2866": 59, "8143": 59, "7311": 59, "3945": 59, "6188": 59, "8159": 59, "8642": 59, "7116": 59, "2387": [59, 156], "0606": [59, 156], "4332": [59, 156], "0024": [59, 81, 156], "3283": 59, "3742": 59, "8303": 59, "0654": [59, 156], "6844": 59, "6873": 59, "3206": 59, "6833": 59, "1309": 59, "9155": 59, "1913": [59, 144, 145, 156], "7285": 59, "8344": 59, "7277": 59, "1437": 59, "9261": 59, "5588": 59, "1644": 59, "6155": [59, 156], "2085": 59, "6490": [59, 156], "7442": 59, "6282": 59, "2525": 59, "9378": 59, "4590": 59, "8298": 59, "5879": 59, "2856": [59, 67], "1654": [59, 156], "5888": 59, "0140": [59, 156], "3604": 59, "9015": 59, "0689": [59, 156], "4604": 59, "5817": 59, "5108": 59, "5646": 59, "2626": [59, 156], "1897": [59, 156], "0861": [59, 156], "4449": 59, "1498": [59, 156], "1902": [59, 156], "7145": 59, "7003": 59, "5286": [59, 156], "2495": 59, "7981": 59, "8534": 59, "8505": 59, "1460": [59, 156], "3943": 59, "1694": [59, 156], "4136": 59, "9135": 59, "8938": 59, "0946": [59, 156], "9810": 59, "0650": [59, 156], "9487": [59, 72], "7587": 59, "7222": 59, "0818": [59, 156], "5605": 59, "7646": 59, "4951": 59, "7642": [59, 156], "9154": 59, "0477": [59, 156], "1082": [59, 156], "4431": 59, "0635": [59, 156], "0176": [59, 125, 156], "9046": 59, "2859": [59, 156], "5276": 59, "8282": 59, "1118": [59, 156], "2808": [59, 156], "8061": 59, "4944": 59, "5851": 59, "6842": 59, "8068": 59, "5898": 59, "8173": 59, "8670": 59, "8147": 59, "0892": [59, 156], "1727": [59, 156], "1832": 59, "0992": [59, 156], "8532": 59, "1337": [59, 156], "6158": 59, "0351": [59, 156], "4265": [59, 156], "0934": [59, 156], "0595": [59, 156], "4273": 59, "5264": 59, "4487": 59, "7385": 59, "4646": 59, "2871": 59, "9519": 59, "0832": [59, 156], "0442": [59, 156], "6573": 59, "1180": [59, 156], "7603": 59, "6874": 59, "3370": 59, "3869": 59, "2031": 59, "2186": [59, 156], "kahweol_xyz": [59, 156], "4710": 59, "5361": 59, "0905": [59, 156], "9753": [59, 113], "0811": [59, 156], "1625": [59, 156], "5695": [59, 156], "0997": [59, 156], "2209": 59, "8317": [59, 156], "2017": [59, 67, 156], "4821": [59, 156], "5357": 59, "4703": 59, "0038": [59, 156], "1167": [59, 156], "0462": [59, 156], "8514": 59, "8737": 59, "1997": 59, "4967": 59, "9058": [59, 156], "1119": [59, 156], "9884": 59, "6333": 59, "0944": [59, 156], "6676": 59, "3924": 59, "2474": 59, "3220": 59, "0551": [59, 156], "4569": 59, "3919": 59, "7479": 59, "1363": [59, 156], "4167": 59, "5304": 59, "9816": 59, "7435": 59, "6786": 59, "3542": 59, "0741": [59, 72, 156], "9483": 59, "1552": 59, "0367": [59, 76, 91, 156], "8330": 59, "6293": 59, "5845": 59, "5870": 59, "9677": 59, "7610": 59, "8511": 59, "4907": 59, "2146": 59, "5444": 59, "1013": 59, "8722": 59, "6493": 59, "8167": 59, "6946": 59, "3059": 59, "2309": [59, 156], "4546": 59, "2464": 59, "3980": [59, 156], "7259": 59, "2399": [59, 156], "3415": 59, "5842": 59, "5631": 59, "6779": 59, "0397": [59, 156], "9072": [59, 156], "1861": 59, "6021": [59, 156], "0159": [59, 125, 156], "2356": [59, 156], "8757": 59, "4322": 59, "3648": 59, "3090": 59, "0216": [59, 156], "9384": 59, "4328": [59, 100], "2098": [59, 156], "1924": [59, 156], "5413": 59, "8043": 59, "9694": 59, "0890": [59, 156], "9406": 59, "0514": [59, 156], "8134": 59, "0921": [59, 156], "9341": 59, "7452": 59, "9434": 59, "2193": [59, 156], "2709": 59, "8849": 59, "6699": 59, "7251": 59, "4553": 59, "0259": [59, 156], "9792": 59, "2481": [59, 156], "6508": 59, "8307": 59, "1490": [59, 156], "0518": [59, 156], "9842": 59, "4166": 59, "6762": 59, "9486": 59, "7233": 59, "0489": [59, 156], "1864": [59, 156], "0524": [59, 156], "1195": [59, 156], "8415": 59, "0679": [59, 156], "4861": 59, "3088": 59, "2088": [59, 156], "7568": 59, "7218": 59, "0925": [59, 156], "2746": [59, 156], "7905": 59, "6240": 59, "7536": 59, "1386": [59, 156], "5085": 59, "4650": [59, 156], "2132": [59, 105], "2149": [59, 113, 156], "0339": [59, 156], "4308": 59, "9731": 59, "4374": 59, "subtl": 59, "opt_cafestol_result": 59, "opt_kahweol_result": 59, "viewergrid": [59, 62, 65, 70, 131, 132, 133, 136, 139, 156, 157, 159], "250": [59, 62], "review": [60, 67, 69], "sny05": [60, 67], "path": [60, 62, 92, 105, 153], "pathpatch": 60, "bohr_in_angstrom": [60, 130, 131, 132, 156], "graphic": [60, 67, 133], "wirefram": 60, "transluc": 60, "plot_wirefram": 60, "plot_surfac": 60, "cmap": [60, 70], "viridi": [60, 70], "view_init": 60, "set_zlabel": 60, "x1": [60, 70, 81, 106, 130, 142, 148], "saddl": [60, 64], "x2": [60, 106, 142, 148], "x3": [60, 106], "repeatedli": 60, "k_i": [60, 66], "adjust": [60, 157], "grad_f": 60, "partial_x": 60, "partial_i": 60, "gradient_desc": 60, "x0": [60, 70, 81], "y0": [60, 81], "f0": [60, 70, 78, 100], "g0": 60, "grad_norm": 60, "opt_data": 60, "function_valu": 60, "gradient_norm": 60, "gradient_descent_opt_data": 60, "traj_gradient_desc": 60, "pcolormesh": 60, "traj": 60, "facecolor": [60, 120], "xpath": 60, "ypath": 60, "add_patch": 60, "histori": 60, "gamma_i": 60, "fletcher": 60, "reev": 60, "polak": 60, "ribier": 60, "conjugate_gradi": 60, "g0_norm": 60, "g_norm": 60, "error_txt": 60, "valueerror": 60, "cg_fletcher_reeves_opt_data": 60, "cg_polak_ribiere_opt_data": 60, "118": [60, 67, 76, 156], "hierarchi": [60, 75], "hessian_f": 60, "partial_xx": 60, "partial_xi": 60, "partial_yx": 60, "partial_yi": 60, "newton_raphson": 60, "trust_radiu": 60, "trust": 60, "inv_h0": 60, "delta_r": 60, "steplen": 60, "inv_h": 60, "newton_raphson_opt_data": 60, "nearest": 60, "graph": [60, 70, 91], "broyden": 60, "goldfarb": 60, "shanno": 60, "differet": 60, "hdlc": 60, "extent": [60, 74, 142], "influenc": [60, 69, 84, 101, 111, 126, 132, 141, 143, 148], "projector": 60, "infrar": [61, 67, 103, 129, 130], "Their": [61, 91], "r_k": 61, "electric_dipole_mo": 61, "cpscf": 61, "electronic_dipole_deriv": 61, "cart": [61, 66], "q_k": [61, 130, 132], "tdhf": [61, 104, 111, 113, 126, 143, 144], "tddft": [61, 81, 104, 105, 108, 111, 113, 123, 126, 128, 141, 143, 146, 149, 153], "rf07": [61, 67], "incid": [61, 89, 117], "gut19": [61, 67], "sigma_k": [61, 130, 151], "omega_k": [61, 151], "radiat": [61, 69, 74, 82, 89, 91, 103, 129, 130, 142, 150], "s_k": 61, "frac19": 61, "depolar": [61, 89], "pol": [61, 142], "depol": 61, "ratio": [61, 89, 99, 150], "forcefieldgener": 62, "topologi": 62, "thiophen": 62, "ligand": [62, 144], "276": 62, "phi_1": 62, "phi_2": 62, "amber": 62, "forcefield": 62, "databas": 62, "pathlib": 62, "read_xyz_fil": [62, 92, 131, 156], "hs276": 62, "ff_gen": 62, "read_qm_scan_xyz_fil": 62, "1_14_15_16": 62, "27_22_21_16": 62, "fh": [62, 133], "dihedral1_xyz": 62, "dihedral2_xyz": 62, "get_xyz_str": [62, 133, 139], "u03c6": 62, "u2081": 62, "u2082": 62, "\u03c6\u2081": 62, "\u03c6\u2082": 62, "resp_chg": 62, "014967": 62, "224409": 62, "089489": 62, "551618": 62, "153050": 62, "106847": 62, "315042": 62, "165854": 62, "206441": 62, "425163": 62, "225816": 62, "039099": 62, "179377": 62, "002119": 62, "014483": 62, "043666": 62, "230202": 62, "165960": 62, "071404": 62, "188598": 62, "044661": 62, "088786": 62, "173586": 62, "175730": 62, "089376": 62, "164515": 62, "118573": 62, "150541": 62, "736497": 62, "570770": 62, "273724": 62, "144051": 62, "112846": 62, "atomtypeidentifi": 62, "atom_typ": 62, "generate_gaff_atomtyp": 62, "molecule_nam": 62, "force_field_data": 62, "dat": 62, "force_field_data_extens": 62, "11_extens": 62, "workdir": 62, "mkdir": 62, "parent": 62, "exist_ok": 62, "original_itp_fil": 62, "ffversion": 62, "02d": 62, "itp": 62, "original_top_fil": 62, "with_suffix": 62, "write_itp": 62, "me": 62, "write_top": 62, "phi_result": 62, "target_dihedr": 62, "validate_force_field": 62, "dihedral_indic": 62, "dihedral_angl": 62, "140": [62, 67, 156], "mm_scan_kjpermol": 62, "39044189": 62, "48483276": 62, "27550507": 62, "36181641": 62, "98594666": 62, "12945557": 62, "5289917": 62, "62785339": 62, "54138184": 62, "5798645": 62, "9957428": 62, "07746887": 62, "94574738": 62, "35903931": 62, "9148407": 62, "06106567": 62, "07492065": 62, "5214386": 62, "qm_scan_kjpermol": 62, "68483744": 62, "04159003": 62, "23524628": 62, "25299405": 62, "80634375": 62, "14209234": 62, "24448683": 62, "88248324": 62, "57298965": 62, "70951563": 62, "2185472": 62, "34950681": 62, "50672143": 62, "13652598": 62, "11846285": 62, "99044409": 62, "39540176": 62, "79216757": 62, "73690796": 62, "89929199": 62, "06036377": 62, "88541412": 62, "83436584": 62, "18778992": 62, "07821655": 62, "53006744": 62, "104": [62, 70, 156], "49455261": 62, "115": [62, 67, 89, 137, 143, 156], "61375427": 62, "45341492": 62, "94953918": 62, "11863708": 62, "92655945": 62, "30844116": 62, "13588715": 62, "1687088": 62, "99819183": 62, "83585497": 62, "39214553": 62, "07446008": 62, "05870708": 62, "79647248": 62, "41640576": 62, "76097693": 62, "36547258": 62, "46062129": 62, "21413969": 62, "26370882": 62, "96902213": 62, "13610802": 62, "45022189": 62, "31569068": 62, "94255437": 62, "29405596": 62, "08664149": 62, "fitted_phi_result": 62, "85865021": 62, "5467453": 62, "92016602": 62, "18968964": 62, "42712402": 62, "39407349": 62, "69501495": 62, "93608093": 62, "92350769": 62, "69535828": 62, "40233612": 62, "13204956": 62, "84503174": 62, "46120453": 62, "05204773": 62, "96090698": 62, "59947205": 62, "49703217": 62, "77013397": 62, "43408203": 62, "92618561": 62, "82312012": 62, "59525299": 62, "37159729": 62, "85509491": 62, "40908813": 62, "28764343": 62, "91279602": 62, "07723999": 62, "00006104": 62, "22518921": 62, "41876221": 62, "14795685": 62, "7151413": 62, "09519958": 62, "07654572": 62, "improved_phi_result": 62, "39545441": 62, "01393127": 62, "20561218": 62, "25416565": 62, "3174057": 62, "2179184": 62, "57676697": 62, "96492004": 62, "10110474": 62, "94235229": 62, "59909821": 62, "18383789": 62, "74294281": 62, "30089569": 62, "21685028": 62, "52063751": 62, "42159271": 62, "43003845": 62, "7759552": 62, "45406342": 62, "97280884": 62, "90036011": 62, "69313049": 62, "46485138": 62, "9087677": 62, "39290619": 62, "19385529": 62, "76613617": 62, "92942047": 62, "90858459": 62, "22563934": 62, "50617981": 62, "2787323": 62, "83068085": 62, "15373993": 62, "05529785": 62, "improved_phi_results_new": 62, "42739868": 62, "89348602": 62, "45018768": 62, "0739975": 62, "42835999": 62, "00170898": 62, "36753082": 62, "33047485": 62, "92477417": 62, "30165863": 62, "63945007": 62, "1234436": 62, "6337204": 62, "46183014": 62, "81786346": 62, "44065094": 62, "93300629": 62, "82655334": 62, "59573364": 62, "37197876": 62, "85752106": 62, "41316223": 62, "29174805": 62, "91529846": 62, "07827759": 62, "00108337": 62, "22787476": 62, "42301941": 62, "15213776": 62, "71668243": 62, "0941925": 62, "08368683": 62, "custom": [62, 144], "script": 62, "content": 62, "custom_plot": 62, "res1": 62, "title1": 62, "res2": 62, "title2": 62, "121": [62, 67, 156], "122": [62, 67, 156], "refit": 62, "target_top_fil": 62, "dihedral_correct": 62, "kt": [62, 76], "update_dihedral_rang": 62, "scan_dih_angl": 62, "raphson": 64, "quasi": 64, "bak86": [64, 67], "candid": 65, "essenc": 65, "ilustr": 65, "intrins": [65, 82], "funtion": 65, "drawxyzgeom": 65, "geom": 65, "compxyzgeom": 65, "init": 65, "geom_xyz": 65, "4059000000": 65, "8128000000": 65, "0009000000": 65, "5654000000": 65, "3926000000": 65, "0383000000": 65, "0196000000": 65, "0052000000": 65, "0386000000": 65, "4291000000": 65, "0210000000": 65, "3741000000": 65, "8940000000": 65, "0007000000": 65, "9546000000": 65, "4028000000": 65, "0003000000": 65, "4958000000": 65, "3375000000": 65, "0011000000": 65, "1970000000": 65, "3166000000": 65, "0018000000": 65, "scf_grad_drv": 65, "scf_opt_drv": 65, "_optim": 65, "48406869": 65, "48588381": 65, "3986767507": 65, "8076140878": 65, "0009002477": 65, "5554932198": 65, "3912703043": 65, "0008560542": 65, "0339417937": 65, "0131015966": 65, "0050309571": 65, "0296875775": 65, "4272388306": 65, "0208045784": 65, "3724942305": 65, "8878930527": 65, "0007271680": 65, "9523159399": 65, "3970927549": 65, "0002038018": 65, "4855076024": 65, "3246755992": 65, "0010344286": 65, "1995439420": 65, "3168060274": 65, "0019270504": 65, "48754838": 65, "3881987993": 65, "8008460851": 65, "0008959673": 65, "5414491982": 65, "3899861931": 65, "0007853320": 65, "0276095642": 65, "0039979473": 65, "0047832956": 65, "0164700299": 65, "4244073465": 65, "0205164352": 65, "3697024299": 65, "8795054853": 65, "0007658631": 65, "9489162104": 65, "3892473489": 65, "0000581691": 65, "4711152364": 65, "3064025713": 65, "0009230192": 65, "2027737500": 65, "3171424570": 65, "0021141842": 65, "48730935": 65, "2694737152": 65, "8199118237": 65, "0020300631": 65, "4650268055": 65, "3557331487": 65, "0014081365": 65, "9624886689": 65, "9369706825": 65, "0070753368": 65, "9114607569": 65, "3882275308": 65, "0242133169": 65, "2776270348": 65, "8879026382": 65, "0037766854": 65, "9579288423": 65, "3019609852": 65, "0042985096": 65, "3994930133": 65, "3005046839": 65, "0013522025": 65, "1661868246": 65, "3716732596": 65, "0018726559": 65, "48730981": 65, "2687990140": 65, "8198482259": 65, "0024123532": 65, "4652286829": 65, "3556615967": 65, "0016439073": 65, "9625706742": 65, "9373517016": 65, "0080640143": 65, "9119100993": 65, "3873539839": 65, "0265832651": 65, "2768799142": 65, "8879461569": 65, "0046771752": 65, "9591653948": 65, "3012461760": 65, "0048335460": 65, "3997144523": 65, "3008164821": 65, "0025853684": 65, "1654403884": 65, "3717101556": 65, "0012082555": 65, "gibb": 65, "1393": [65, 105, 156], "rot": [65, 75, 101, 124, 148], "vib": [65, 66], "tot": 65, "4904": 65, "8942": [65, 156], "9940": 65, "3787": [65, 156], "6717": 65, "9750": 65, "9343": 65, "6015": 65, "4925": 65, "4803": 65, "5743": 65, "e0": [65, 101], "149025": 65, "5369": 65, "zpve": 65, "02859519": 65, "9438": 65, "45871462": 65, "149007": 65, "5931": 65, "comparis": 65, "vdata_last": 65, "628": [65, 156], "204633": 65, "330398": 65, "000411": 65, "001108": 65, "368626": 65, "108966": 65, "000569": 65, "307556": 65, "056006": 65, "004238": 65, "506299": 65, "335269": 65, "039828": 65, "199547": 65, "012314": 65, "001551": 65, "295694": 65, "218857": 65, "000577": 65, "278836": 65, "133604": 65, "000508": 65, "059067": 65, "024571": 65, "001489": 65, "coord_t": 65, "freq_xyz": 65, "cm": [65, 66, 76, 82, 84, 91, 98, 100, 111, 124, 130, 131, 132, 150, 156], "freq": [65, 89, 113, 124, 142, 144, 156], "coord_freq": 65, "ts_vib": 65, "02204438e": 65, "55006529e": 65, "46487032e": 65, "46548310e": 65, "66187114e": 65, "03128041e": 65, "40019156e": 65, "87717400e": 65, "23011918e": 65, "56975291e": 65, "98815248e": 65, "50289216e": 65, "03586415e": 65, "54443109e": 65, "17695454e": 65, "14350535e": 65, "87257868e": 65, "02244501e": 65, "28227452e": 65, "71066186e": 65, "92565734e": 65, "09074270e": 65, "55997931e": 65, "30530216e": 65, "ddagger": 65, "react": 65, "Will": [65, 147], "52638154": 65, "9112351040": 65, "1624677572": 65, "0006980640": 65, "0548281772": 65, "0782577796": 65, "0004981290": 65, "3015267488": 65, "8281271773": 65, "0008357891": 65, "8259069457": 65, "7432222546": 65, "0231535592": 65, "8632242900": 65, "3826709271": 65, "0017612332": 65, "0964503076": 65, "2975291731": 65, "0015528206": 65, "9848455585": 65, "9798798745": 65, "0056716903": 65, "2831586608": 65, "0548212877": 65, "0000093104": 65, "tst": 65, "50434988": 65, "149036": 65, "2297": [65, 156], "g_t": 65, "g_reac": 65, "delta_g": [65, 122], "eyr": 65, "k_b": 65, "958e": 65, "3806e": 65, "6261e": 65, "202e": 65, "irc_forw_xyz": 65, "26880": 65, "81980": 65, "00240": [65, 75], "46520": 65, "35570": 65, "00160": 65, "55580": 65, "91590": 65, "00620": 65, "50510": 65, "36590": 65, "02850": 65, "27690": 65, "88790": 65, "00470": 65, "95920": 65, "30120": 65, "00480": 65, "00710": 65, "32220": 65, "00070": 65, "75870": 65, "39310": 65, "00310": [65, 75], "artifact": 65, "prod_xyz": 65, "pentacycl": 65, "72239707": 65, "8617419369": 65, "8032549747": 65, "0043906460": 65, "2297358489": 65, "4963316637": 65, "0026018408": 65, "5141177188": 65, "7772456796": 65, "0085738694": 65, "1667292050": 65, "5672508556": 65, "0149134240": 65, "4243082245": 65, "7254211048": 65, "0060026334": 65, "2182366655": 65, "9261003405": 65, "0078164842": 65, "0829962370": 65, "3043435852": 65, "0024523167": 65, "9785719893": 65, "5290970262": 65, "0043900689": 65, "9789": 65, "4011": [65, 156], "7857": 65, "0801": [65, 156], "7246": 65, "4763": 65, "2240": [65, 156], "5174": 65, "3429": 65, "149173": 65, "0564": [65, 156], "04051209": 65, "4217": 65, "68188498": 65, "149147": 65, "6346": 65, "g_prod": 65, "reac_g": 65, "deciu": [66, 67], "wdc80": [66, 67], "hessian_matrix_el": 66, "x_i": [66, 70], "coordiat": 66, "deri": 66, "mwc": 66, "m_1": 66, "m_n": 66, "m_i": [66, 91], "hessian_mwc": 66, "center_of_mass": [66, 81], "inertia": 66, "eckart": [66, 67], "eck35": [66, 67], "gram": [66, 72], "schmidt": [66, 72], "six": [66, 82, 97, 124, 125], "hessian_to_intern": 66, "hessian_internal_diagon": 66, "lambda_i": [66, 94], "nu_i": 66, "wavenumb": [66, 130, 131, 132, 156], "reciproc": 66, "centimet": 66, "vibrations_wavenumb": 66, "undo": 66, "spectral": [66, 70, 73, 150], "reduced_mass": [66, 100], "force_const": 66, "raman": [66, 67, 129, 141], "adj21": [67, 149], "ambrois": 67, "jensen": 67, "2832": 67, "2021": [67, 156], "url": [67, 133], "jctc": 67, "1c00042": 67, "bs71": [67, 144], "bagu": 67, "schaefer": 67, "artre": 67, "ock": 67, "1474": [67, 156], "1971": [67, 156], "1063": [67, 156], "1676248": 67, "baker": 67, "385": 67, "395": [67, 143], "1986": 67, "1002": [67, 156], "jcc": 67, "540070402": 67, "bar04": [67, 82, 91], "laurenc": [67, 91], "barron": [67, 91], "cambridg": 67, "2004": 67, "1017": [67, 156], "cbo9780511535468": 67, "bayli": 67, "cieplak": 67, "cornel": 67, "pub": 67, "j100142a004": 67, "rev": 67, "3098": 67, "3100": 67, "1103": [67, 124, 156], "physreva": 67, "thermochemistri": 67, "5648": 67, "5652": [67, 156], "464913": 67, "byy17": [67, 141], "bergmann": 67, "yachandra": 67, "yano": 67, "laser": [67, 76, 82, 96, 111, 117, 148], "biologi": 67, "societi": 67, "isbn": 67, "84973": 67, "1039": [67, 156], "9781782624097": 67, "besler": 67, "semiempir": 67, "431": 67, "439": 67, "onlinelibrari": 67, "wilei": 67, "540110404": 67, "bes12": [67, 149], "beslei": 67, "lett": 67, "542": [67, 144], "2012": 67, "1016": [67, 144, 145, 156], "cplett": 67, "bes21": [67, 144], "wire": 67, "sci": 67, "wcm": 67, "1527": 67, "ba10": [67, 144, 149], "asmuruf": 67, "12024": 67, "12039": 67, "2010": [67, 156], "c002207a": 67, "curt": 67, "breneman": 67, "kenneth": 67, "wiberg": 67, "monopol": [67, 84], "formamid": 67, "540110311": 67, "buc67": [67, 84], "buckingham": [67, 74, 84, 91], "adv": 67, "1967": [67, 156], "9780470143582": 67, "ch2": [67, 142], "caldeweyh": 67, "ehlert": 67, "hansen": 67, "neugebau": 67, "spicher": 67, "bannwarth": 67, "ondon": 67, "154122": 67, "2019": 67, "5090222": 67, "cds80": [67, 69, 144], "cederbaum": 67, "domck": 67, "schirmer": 67, "206": 67, "cen15": [67, 130], "centron": 67, "diffract": 67, "annu": 67, "anal": 67, "101": [67, 150, 156], "126": [67, 89, 156], "2015": [67, 156], "1146": [67, 156], "annurev": 67, "anchem": 67, "071114": 67, "040435": 67, "multimolecul": 67, "multiconform": 67, "methodologi": 67, "biopolym": 67, "dna": 67, "rna": 67, "1357": 67, "1377": [67, 156], "1995": [67, 156], "540161106": 67, "cohen": 67, "mori": 67, "s\u00e1nchez": 67, "289": [67, 142], "320": 67, "cr200107z": 67, "deglmann": 67, "furch": 67, "ahlrich": 67, "362": [67, 124, 144], "511": 67, "518": [67, 106, 148], "2002": [67, 156], "s0009": 67, "2614": 67, "01084": 67, "phenomena": [67, 74, 113], "homa": 67, "math": 67, "proc": 67, "camb": 67, "philo": 67, "soc": 67, "376": 67, "1930": 67, "s0305004100016108": 67, "gordon": 67, "4009": [67, 156], "4037": 67, "2005": [67, 156], "cr0505627": 67, "wormit": [67, 70], "1206": [67, 156], "polyatom": 67, "552": [67, 70, 150], "558": [67, 144], "1935": [67, 156], "physrev": 67, "ekstromncaagren06": [67, 144], "ekstr": 67, "\u00f6": 67, "carravetta": 67, "gren": 67, "2006": 67, "physrevlett": 67, "143001": 67, "erdew": 67, "urk": 67, "rnzerhof": 67, "5029": 67, "5036": [67, 156], "1999": 67, "478401": 67, "foresman": 67, "popl": 67, "1992": [67, 156], "j100180a030": 67, "fpb18": [67, 144], "fouda": 67, "purnel": 67, "ultra": 67, "reson": [67, 113, 117, 129, 141, 143, 145], "inelast": [67, 129, 141], "2586": 67, "2595": [67, 100], "2018": [67, 76, 89, 98, 148, 156], "8b00211": 67, "fbv": [67, 149], "vidal": 67, "coriani": 67, "xaboom": 67, "nitrogen": 67, "1618": [67, 156], "0c01082": 67, "fbn16": [67, 143], "burdakova": 67, "edg": [67, 69, 141, 143, 144, 148, 149], "silicon": [67, 143, 150], "germanium": 67, "sulfur": 67, "compound": [67, 86, 88, 92, 100, 143, 149], "damp": [67, 76, 83, 89, 98, 113, 124, 142, 143, 144], "13591": 67, "13603": 67, "2016": 67, "c6cp00561f": 67, "fd19": [67, 144, 149], "546": 67, "556": 67, "8b01046": 67, "fbr14": [67, 82], "daniel": 67, "fries": 67, "maarten": 67, "beerepoot": 67, "ruud": 67, "multiphoton": [67, 117], "204103": 67, "2014": [67, 70], "4901563": 67, "adiabat": [67, 99, 100, 111], "117": [67, 156], "7433": 67, "7447": 67, "1508368": 67, "g\u00f6rling": 67, "2783": 67, "2799": [67, 156], "gagliardi": 67, "lindh": 67, "karlstr": 67, "rop": 67, "4494": 67, "4500": 67, "1778131": 67, "gbg08": [67, 144], "gilbert": 67, "gill": 67, "mom": [67, 143, 144, 145, 148, 150], "13164": 67, "13171": 67, "2008": [67, 156], "jp801738f": 67, "antoni": 67, "ehrlich": 67, "krieg": 67, "154104": 67, "guthmul": 67, "497": 67, "son": 67, "ltd": 67, "9783527814596": 67, "ch17": 67, "hhgb18": [67, 149], "hanson": 67, "hein": 67, "georg": 67, "699": 67, "hat06": [67, 71], "hattig": 67, "nanosci": 67, "245": 67, "278": 67, "juser": 67, "fz": 67, "juelich": 67, "record": 67, "152600": 67, "fzj": 67, "02217": 67, "pdf": [67, 159], "hggmw95": [67, 153], "grana": 67, "mauric": 67, "white": [67, 133, 159], "attach": [67, 105, 125, 126, 145], "detach": [67, 105, 125, 126, 145], "14261": 67, "j100039a012": 67, "helgak": 67, "j\u00f8rgensen": 67, "183": 67, "s0065": 67, "3276": 67, "60616": 67, "olsen": [67, 75], "9781119019572": 67, "hf20": [67, 69, 144], "herbst": 67, "quantifi": 67, "153": [67, 125], "054114": 67, "2020": [67, 156], "0013538": 67, "dyke": 67, "ortenburg": 67, "statist": 67, "807": 67, "811": 67, "1969": 67, "hirata": 67, "amm": 67, "ancoff": 67, "314": 67, "291": [67, 150], "299": [67, 143, 144], "01149": 67, "hdsd22": [67, 72], "dempwolff": 67, "156": [67, 125], "074104": 67, "0070967": 67, "rehn": 67, "h\u00f6fener": 67, "164125": 67, "aip": 67, "scitat": 67, "5093606": 67, "136": [67, 136, 156], "b864": 67, "b871": 67, "hlumartinez15": [67, 71], "hohenstein": 67, "luehr": 67, "ufimtsev": 67, "mart": 67, "\u00ed": 67, "nez": 67, "142": [67, 150], "224103": 67, "4921956": 67, "kkg": [67, 143], "kadek": 67, "konecni": 67, "gao": 67, "repiski": 67, "irac": 67, "ohn": 67, "22566": 67, "22570": 67, "c5cp03712c": 67, "kie72": [67, 84], "kielich": 67, "isotop": 67, "dielectr": [67, 89, 91], "davi": 67, "editor": [67, 133], "specialist": 67, "report": 67, "192": 67, "1972": [67, 156], "kim": 67, "bacteriochlorophyl": 67, "enna": 67, "atthew": 67, "lson": 67, "5235": 67, "5246": 67, "6b00647": 67, "ksk": [67, 144], "king": 67, "stanton": 67, "wyatt": 67, "nonorthogon": 67, "1936": [67, 156], "1712221": 67, "koj95": [67, 89], "kirpekar": 67, "oddershed": 67, "103": [67, 100, 125, 156], "2983": 67, "470486": 67, "a1133": 67, "a1138": 67, "klp": [67, 144], "kowalska": 67, "lima": 67, "pollock": 67, "ree": 67, "debeer": 67, "bioinorgan": 67, "isr": [67, 68, 72, 73], "803": 67, "815": 67, "ijch": 67, "201600037": 67, "lle": 67, "alvetti": 67, "789": [67, 156], "physrevb": 67, "levchenko": 67, "substitut": [67, 131, 142, 143], "phd": 67, "thesi": 67, "southern": 67, "california": 67, "wang": 67, "krylov": 67, "224106": 67, "1877072": 67, "natl": 67, "acad": 67, "6062": [67, 156], "6065": 67, "1979": [67, 156], "1073": [67, 156], "pna": 67, "606": 67, "lpl": [67, 80], "parrish": 67, "liu": 67, "kokkila": 67, "schumach": 67, "exciton": [67, 94, 102, 103, 105], "3493": 67, "3504": 67, "7b00171": 67, "lvkkg12": [67, 144], "lopata": 67, "kuiken": 67, "khalil": 67, "govind": 67, "3284": 67, "3292": 67, "ct3005613": 67, "ls61": [67, 144], "lyko": 67, "schmeis": 67, "288": [67, 113], "1961": [67, 156], "1731901": 67, "263": 67, "60318": 67, "mar03": [67, 94], "richard": 67, "martin": 67, "4775": 67, "4777": 67, "1558471": 67, "mat92": [67, 73], "mattuck": 67, "diagram": [67, 70, 73, 123], "courier": 67, "corpor": 67, "ms96": [67, 72], "mertin": 67, "biorthogon": 67, "2140": 67, "2152": [67, 156], "1996": [67, 156], "nees": 67, "253": 67, "563": 67, "2009": [67, 156], "ccr": 67, "et": [67, 88], "al": [67, 72], "orca": 67, "nbjo01": [67, 144], "bishop": 67, "Near": 67, "10323": 67, "10334": 67, "1415081": 67, "nd18": [67, 69, 141, 144, 149], "7208": 67, "7248": 67, "chemrev": 67, "8b00156": 67, "nrs18": [67, 78, 88, 99, 108, 113, 130], "saue": 67, "nl14": [67, 102], "patrick": 67, "mathieu": 67, "linar": 67, "circular": [67, 89, 91, 102, 117, 148], "dichroism": [67, 82, 89, 102, 148], "\u03c0": 67, "stack": [67, 102, 105], "ethylen": [67, 94, 96, 102, 105, 113, 115], "483": 67, "489": 67, "chir": 67, "22331": 67, "pmk21": [67, 149], "paul": 67, "myhr": 67, "koch": 67, "cc3": [67, 128, 149], "0c00686": 67, "pbapplerwd14": [67, 153], "plasser": [67, 70], "\u00e4": 67, "ppler": 67, "pplicat": 67, "024107": 67, "4885820": 67, "pwd14": [67, 153], "ormal": 67, "024106": [67, 70], "4885819": 67, "krishnan": 67, "schlegel": 67, "binklei": 67, "m\u00f8": 67, "ller": 67, "lesset": 67, "225": 67, "241": 67, "qua": 67, "560160825": 67, "pulai": 67, "393": [67, 90], "398": 67, "0009": [67, 156], "80396": 67, "560": 67, "1982": [67, 156], "540030413": 67, "fogarasi": 67, "2860": [67, 156], "462844": 67, "rappoport": 67, "aman": 67, "201104": 67, "2007": [67, 156], "2744026": 67, "heidelberg": 67, "174110": 67, "5085117": 67, "scheurer": 67, "brand": 67, "1528": 67, "park": 67, "ion": [67, 144], "quant": 67, "116": [67, 98, 156], "573": 67, "577": 67, "25064": 67, "vahtra": 67, "ahmadzadeh": 67, "ringholm": 67, "scott": 67, "velox": 67, "hem": 67, "ython": 67, "e1457": 67, "1457": 67, "sch82": [67, 73], "2395": [67, 156], "2416": [67, 81], "sch91": [67, 72], "4647": 67, "4659": 67, "1991": [67, 156], "sm10": [67, 72], "theor": 67, "acc": 67, "125": [67, 70, 156], "172": [67, 100], "springer": 67, "1007": [67, 156], "s00214": 67, "009": 67, "0597": [67, 156], "st04": [67, 72], "trofimov": 67, "11449": 67, "11464": 67, "1752875": 67, "harrel": 67, "seller": 67, "560450106": 67, "458": [67, 70], "468": 67, "4684": 67, "1890": 67, "3_36": 67, "shavitt": 67, "bartlett": 67, "mbpt": 67, "cbo9780511596834": 67, "sh07": [67, 130], "siebert": 67, "hildebrandt": 67, "9783527621347": 67, "chandra": 67, "singh": 67, "peter": 67, "540050204": 67, "snyman": 67, "stephen": [67, 76, 89, 98, 148], "devlin": [67, 76, 89, 98, 148], "chabalowski": [67, 76, 89, 98, 148], "frisch": [67, 76, 89, 98, 148], "11623": [67, 76, 89, 98, 148], "11627": 67, "1994": [67, 76, 89, 98, 148, 156], "j100096a001": 67, "stratmann": 67, "257": 67, "213": 67, "223": [67, 90, 124, 143, 144], "00600": 67, "stohr92": [67, 69], "hr": 67, "nexaf": [67, 144], "busi": 67, "media": [67, 82], "szabo": 67, "ostlund": 67, "climb": 67, "nonempir": 67, "meta": 67, "146401": 67, "treutler": 67, "102": [67, 76, 156], "346": 67, "354": 67, "469408": 67, "vbl16": [67, 141], "bokhoven": 67, "laberti": 67, "9781118844236": 67, "9781118844243": 67, "vfe": [67, 144, 149], "feng": 67, "epifanovski": 67, "3117": 67, "3133": 67, "9b00039": 67, "vkc19": [67, 144], "dyson": [67, 144], "fc": [67, 133], "cv": [67, 68, 69, 142, 146], "eom": 67, "photoelectron": 67, "2693": [67, 156], "c9cp03695d": 67, "lenth": 67, "duijneveldt": 67, "643": 67, "651": 67, "459511": 67, "nusair": 67, "liquid": [67, 74, 82], "1211": [67, 156], "1139": [67, 156], "p80": 67, "159": [67, 83], "wagniere82a": [67, 82], "wagni": 67, "\u00e9": 67, "2786": 67, "444166": 67, "wagniere82b": [67, 82], "473": [67, 70], "442747": 67, "song": 67, "214108": 67, "4952956": 67, "yu": 67, "8487": 67, "8492": [67, 156], "1705670114": 67, "wbm": [67, 144], "weinhardt": 67, "benkert": 67, "meyer": 67, "blum": 67, "reinert": 67, "hesk": 67, "spectat": 67, "soft": [67, 69], "144311": 67, "3702644": 67, "wen16": [67, 72], "wenzel": 67, "whwd15": [67, 144, 149], "holzer": 67, "214104": 67, "4921841": 67, "dover": 67, "york": 67, "wor09": [67, 72, 73], "harvest": 67, "goeth": 67, "frankfurt": 67, "yanai": 67, "tew": 67, "handi": 67, "attenu": [67, 98, 141], "zhao": 67, "innesota": 67, "502": 67, "2011": [67, 156], "060": 67, "lachjs04": [67, 89], "\u0142": 67, "ach": 67, "jeziorski": 67, "szalewicz": 67, "radi": [67, 123], "233001": 67, "intract": 69, "schemat": [69, 72, 73, 123], "reduct": [69, 144], "characteris": 69, "sensit": [69, 98, 141, 144], "xa": [69, 141, 142, 144, 149], "ref": [69, 102, 143], "continuum": [69, 106, 124, 141, 143], "alongsid": [69, 97, 128], "dichloroethylen": 69, "sim": [69, 111, 113, 143, 144], "290": [69, 143], "ev": [69, 70, 72, 75, 81, 90, 100, 101, 102, 105, 113, 115, 124, 125, 142, 143, 144, 145, 148, 150, 153], "speci": 69, "volt": [69, 150], "peak": [69, 130, 131, 143, 151], "inequival": 69, "pronounc": [69, 120], "polaris": 69, "counteract": [69, 143], "pi_": [70, 73], "n0": [70, 73, 75, 90, 99, 117], "gamma_n": [70, 73], "pole": [70, 73, 89], "broaden": [70, 73, 81, 124, 125, 130, 131, 142, 143, 144, 156, 158], "mathbb": 70, "mx": 70, "e_n": [70, 72, 73, 99], "mointsdriv": 70, "colormap": 70, "au2ev": [70, 75, 90, 101, 106, 124, 125, 142, 143, 144, 145, 148, 150, 151], "hartree_in_ev": [70, 81], "lih_xyz": [70, 72], "basis_set_label": [70, 72, 100, 131, 132, 143], "run_scf": [70, 72, 124, 125, 142, 144, 145, 153], "1561447194": [70, 143, 148], "963513321178": 70, "963513323402": 70, "00002852": 70, "00000681": 70, "963513323651": 70, "0000000002": [70, 120, 143], "00000905": 70, "00000208": 70, "00002371": 70, "963513323683": 70, "00000065": 70, "00000015": 70, "00001205": 70, "00000002": [70, 120, 143], "00000042": 70, "00000001": [70, 72, 120], "9635133237": 70, "1196580431": 70, "24239": 70, "26646": 70, "61559": 70, "45278": 70, "39107": 70, "60182": 70, "73721": 70, "orb_view": 70, "mo_energi": [70, 113, 143], "moints_drv": [70, 113], "nvir": [70, 81], "nexc": [70, 72, 94], "adc0_mat4d": 70, "adc1_mat4d": 70, "fill": [70, 144], "4d": 70, "adc0_mat2d": 70, "adc1_mat2d": 70, "nclose": 70, "844": 70, "868": 70, "217": 70, "353": [70, 150], "055": 70, "128": [70, 143, 156], "021": 70, "154": [70, 83, 100], "046": [70, 125], "064": 70, "504": [70, 144], "788": 70, "041": 70, "048": 70, "721": 70, "481": 70, "adc0_eigv": 70, "adc0_eigvec": 70, "adc1_eigv": 70, "adc1_eigvec": 70, "567": 70, "570": 70, "548": 70, "dimensionless": [70, 150], "frac23": 70, "adc0_tdm": 70, "adc1_tdm": 70, "cis_tdm": 70, "t2_dict": 70, "mo_occ": [70, 143, 144, 145, 148], "mo_vir": 70, "n_state": [70, 90, 101, 122, 143, 144, 145, 148], "sqrt2": 70, "gamma_adc0": 70, "t_term": 70, "gamma_adc1": 70, "gamma_ci": 70, "dipole_ints_ao": 70, "adc0_osc_str": 70, "adc1_osc_str": 70, "cis_osc_str": 70, "tdm0": 70, "tdm1": 70, "tdm_ci": 70, "f1": 70, "f_ci": 70, "xmn": 70, "lorentzian": [70, 81, 106, 124, 125, 130, 131, 132, 142, 143, 144, 148, 156], "add_broaden": [70, 130, 131, 132, 156], "xb": 70, "yb": 70, "line_profil": [70, 130, 131, 132, 156], "lorentizan": 70, "fwhm": [70, 151], "hwhm": [70, 151], "xb_move": 70, "yb_move": 70, "x_min": [70, 130, 131, 132, 156], "x_max": [70, 130, 131, 132, 156], "zeros_lik": 70, "x_adc0": 70, "y_adc0": 70, "x_adc1": 70, "y_adc1": 70, "x_ci": 70, "y_ci": 70, "darkr": 70, "grai": 70, "adc1_result": 70, "run_adc": [70, 124, 125, 142, 144, 145, 153], "adc1": [70, 143], "tol": 70, "jacobi": [70, 125], "niter": [70, 125], "n_ss": [70, 125], "max_residu": [70, 125], "ritz": [70, 125], "7186e": 70, "34m": 70, "614": 70, "701": 70, "806": 70, "220m": 70, "x_gator": 70, "y_gator": 70, "excitation_energi": [70, 81, 100, 124, 125, 142, 143, 144, 148], "oscillator_strength": [70, 81, 100, 102, 105, 106, 113, 124, 125, 142, 143, 144, 148, 151], "506": [70, 144, 156], "nci": 70, "063": 70, "095": 70, "581": 70, "052": [70, 113], "087": 70, "077": 70, "058": 70, "169": [70, 100], "705": 70, "016": [70, 125], "kappa_i": 70, "gamma_a": 70, "d_i": 70, "gamma_d": 70, "p_a": 70, "p_d": 70, "calculate_difference_dens": 70, "ddm_mo": 70, "get_attachement_detach": 70, "density_mo": 70, "density_ao": 70, "new_dens": 70, "k_ao": 70, "w_ao": 70, "k_detach": [70, 153], "k_ao_d": 70, "k_attach": [70, 153], "k_ao_a": 70, "detach_mo": 70, "attach_mo": 70, "detach_ao": [70, 153], "attach_ao": [70, 153], "mo_coeff": [70, 143, 144, 145, 148], "cube_point": 70, "cubic_grid": 70, "gen_cubic_grid": 70, "detach_adc1": 70, "attach_adc1": 70, "pd": 70, "cube": [70, 105, 153], "dens_da": 70, "detach_cube_nam": 70, "_adc1_": 70, "d_detach": 70, "attach_cube_nam": 70, "d_attach": 70, "nwrite": 70, "write_data": 70, "isoval_d": 70, "isoval_a": 70, "800": [70, 130, 157, 159], "name_d": 70, "name_a": 70, "addvolumetricdata": [70, 157], "isov": [70, 157], "09469": 70, "904": 70, "425": 70, "convention": 71, "workstat": 71, "portion": [71, 92], "facilit": 71, "eigenproblem": 71, "dd": [71, 72], "rewritten": [71, 82, 124], "elimin": [71, 84], "eigensolv": [71, 148], "precursor": 72, "isdefinit": 72, "mdef": 72, "psi_l": 72, "adc_eigenvalue_eq": 72, "my": 72, "mseri": 72, "subblock": 72, "oder": 72, "hoc": [72, 143], "imbalanc": 72, "adcmat_ph_ph_0": 72, "adcmat_ph_ph_1": 72, "adcmat_ph_ph_2": 72, "ackl": 72, "bckl": 72, "cdik": 72, "jkcd": 72, "acik": 72, "jkbc": 72, "adcmat_ph_2p2h_1": 72, "id": [72, 133], "ak": 72, "il": [72, 82], "c2p2hph_1": 72, "cj": [72, 144], "adcmat_2p2h_2p2h_0": 72, "bd": 72, "klab": 72, "jlab": 72, "jcd": 72, "ijcd": 72, "jkc": 72, "ijbd": 72, "ikac": 72, "klc": 72, "klac": 72, "klbc": 72, "kcd": 72, "ikcd": 72, "imposs": [72, 74, 89, 148], "smallest": [72, 143], "overcom": [72, 101], "secular": 72, "ucc": 72, "share": [72, 120], "jn": 72, "d_n": 72, "psi_m": 72, "_m": 72, "adconedriv": 72, "adctwodriv": 72, "lih": 72, "basis_lih": 72, "basis_h2o": 72, "scf_lih": 72, "scf_h2o": 72, "e_scf_lih": 72, "e_scf_h2o": 72, "thrice": 72, "adc1_drv": 72, "adc1_results_h2o": 72, "adc1_results_lih": 72, "adc2_drv": 72, "adc2_results_h2o": 72, "adc2_results_lih": 72, "qq_den": 72, "batch": [72, 76, 89, 98, 148], "imb": 72, "49e": 72, "36669368": 72, "11478601": 72, "44840498": 72, "13775605": 72, "46360595": 72, "14905941": 72, "52e": [72, 89], "08e": 72, "35291511": 72, "01136344": 72, "42544431": 72, "00107731": 72, "44554970": 72, "04521708": 72, "67e": [72, 76], "36e": [72, 98], "35279762": 72, "00151889": 72, "42544293": 72, "00001364": 72, "44369379": 72, "00767191": 72, "35279702": 72, "00033748": 72, "44360836": 72, "00228847": 72, "90e": [72, 148], "35279701": 72, "00000654": 72, "44360608": 72, "00088952": 72, "00000010": [72, 143], "44360599": 72, "00010839": 72, "05e": 72, "00000483": 72, "60010": 72, "osc": [72, 100, 113, 124, 125, 144, 145, 148, 151, 153], "01663": 72, "57689": 72, "07113": 72, "11240": 72, "60e": 72, "47e": 72, "15889294": 72, "01952183": 72, "20608326": 72, "01468372": 72, "21659287": 72, "03602681": 72, "28273182": 72, "01773908": 72, "33269430": 72, "01820955": 72, "33539479": 72, "02560730": 72, "15870155": 72, "00048111": 72, "20597994": 72, "20599656": 72, "00587184": 72, "28256950": 72, "00084005": 72, "33252586": 72, "33360191": 72, "04595089": 72, "15870142": 72, "00001296": 72, "00000164": 72, "28256876": 72, "00004259": 72, "00002258": 72, "69e": [72, 76], "10e": 72, "31849": 72, "02843": 72, "60500": 72, "25169": 72, "68909": 72, "04341": 72, "s5": [72, 81], "04849": 72, "02652": 72, "s6": [72, 81], "gb": [72, 76, 89, 98, 148], "spent": [72, 76, 98], "usag": 72, "73e": [72, 98, 148], "00000658": 72, "00089376": 72, "11e": 72, "00011110": 72, "59e": 72, "00000459": 72, "1274706653": 72, "98e": 72, "50e": [72, 148], "31462536": 72, "87e": [72, 98], "42e": 72, "31187300": 72, "31185626": 72, "21e": 72, "31185616": 72, "40125793": 72, "39816818": 72, "39816521": 72, "39816520": 72, "40309707": 72, "40288697": 72, "40288696": 72, "d_sigma": 72, "48604": 72, "v1": [72, 124, 125, 142, 144, 145, 153], "9595": 72, "83463": 72, "9638": 72, "96311": 72, "9573": 72, "9772": 72, "0541": [72, 156], "9765": 72, "0824": [72, 156], "0588": [72, 156], "9722": 72, "0749": [72, 156], "0136828971": 72, "76e": [72, 76], "14174508": 72, "39e": [72, 76], "14168623": 72, "14168468": 72, "14168467": 72, "18797246": 72, "66e": 72, "18637063": 72, "18637029": 72, "18637028": 72, "81e": 72, "26955011": 72, "26694944": 72, "26694790": 72, "85e": [72, 76], "32063129": 72, "53e": [72, 98], "31893708": 72, "31893873": 72, "31996133": 72, "31993255": 72, "85544": 72, "9645": 72, "07139": 72, "9634": 72, "26402": 72, "9652": [72, 156], "67876": 72, "9662": 72, "70581": 72, "9719": 72, "2366": 72, "0915": [72, 156], "9160": 72, "2533": [72, 156], "2254": [72, 156], "0964": [72, 156], "9756": 72, "0876": [72, 156], "9512": 72, "2365": 72, "0707": [72, 156], "8875": 72, "3356": 72, "2596": [72, 156], "0633": [72, 156], "nh2o": 72, "nlih": 72, "1587": 72, "20598": 72, "28257": 72, "33253": 72, "3528": 72, "42544": 72, "44361": 72, "14168": 72, "18637": 72, "26695": 72, "31894": 72, "31993": 72, "31186": 72, "39817": 72, "40289": 72, "lih_h2o_xyz": 72, "lih_h2o": 72, "basis_lih_h2o": 72, "scf_lih_h2o": 72, "85469422644599": 72, "adc1_results_lih_h2o": 72, "adc2_results_lih_h2o": 72, "33477": 72, "14169": 72, "event": 73, "planck": [73, 150], "annihil": [73, 97, 111, 141, 143], "lifetim": [73, 113, 130], "inspir": [73, 136, 143], "wiggli": 73, "lift": [73, 90], "knock": 73, "recombin": 73, "emit": [73, 91, 92, 144], "arrow": [73, 91, 120], "postul": 73, "perhap": [73, 100], "tip": 74, "unpolar": 74, "ellipt": [74, 89], "circularli": [74, 82], "ellips": 74, "statu": 74, "refract": [74, 76, 89, 91], "laboratori": [74, 76, 98, 100], "bot": 74, "beam": [74, 76, 82, 117], "exit": 74, "lin": 74, "kerr": [74, 76, 89], "electro": [74, 76, 98], "anisotrop": 74, "preferenti": 74, "emerg": 74, "anisotropi": [74, 89], "hyperpolariz": [74, 91, 150], "cotton": 74, "mouton": 74, "magneto": 74, "fluid": [74, 76, 82, 89], "perpendicularli": 74, "excess": [74, 122], "wavelength": [74, 82, 91, 124, 150], "rotatori": [74, 75, 90, 101, 124], "ord": 74, "faradai": [74, 150], "magnetochir": 74, "uparrow": 74, "antiparallel": 74, "a_2": 74, "reorgan": [74, 144], "reorient": 74, "dipolar": 74, "saw": 75, "irradi": [75, 111], "f_n": 75, "122760": 75, "708185001": 75, "793127822": 75, "799861180": 75, "800508543": 75, "800565380": 75, "800574227": 75, "800575131": 75, "800575290": 75, "800575329": 75, "800575338": 75, "800575340": 75, "12020540305318": 75, "98825": 75, "96801": 75, "97145": 75, "98065": 75, "00050": 75, "02821": 75, "01813": [75, 101], "02666": 75, "01218": 75, "00063": 75, "00222": 75, "8096766326331": 75, "98999": 75, "96500": 75, "97826": 75, "99416": 75, "99612": 75, "03529": 75, "00360": [75, 120], "00679": 75, "01598": 75, "00969": 75, "00250": 75, "00263": 75, "72755706157518": 75, "98934": 75, "97697": 75, "96858": 75, "99423": 75, "03496": 75, "99438": 75, "00381": 75, "00671": 75, "00220": 75, "01152": 75, "01394": 75, "00335": 75, "71682482474854": 75, "98622": 75, "95656": 75, "14202": 75, "98084": 75, "84833": 75, "04126": 75, "00283": 75, "01796": 75, "01163": 75, "00636": 75, "62861277592357": 75, "98447": 75, "95661": 75, "01098": 75, "98207": 75, "04117": 75, "97797": 75, "00370": 75, "01636": 75, "00441": 75, "00643": 75, "01380": 75, "00204": 75, "211386": [75, 90, 101, 106, 124, 125, 143, 144, 145, 148], "_get_active_mo": 75, "dipole_mo": 75, "icomp": 75, "dendriv": 75, "tden": 75, "get1den": 75, "dx": [75, 100], "tensordot": 75, "dy": 75, "450": 75, "01319": [75, 120], "685": [75, 156], "977": 75, "11535": 75, "377": [75, 156], "11499": 75, "dark": [75, 102], "interst": [75, 101, 124], "diposc": [75, 101, 124], "greather": [75, 101, 124], "44992": [75, 90, 101], "318937e": 75, "625297e": 75, "97654": [75, 90, 101], "153538e": 75, "749710e": 75, "37692": [75, 90, 101], "149882e": 75, "223962e": 75, "cg": [75, 90, 101, 124, 148], "exc": [75, 90, 100, 113], "gasscf": 75, "cumul": 75, "642674442": 75, "98387037576919": 75, "63914005847887": 75, "99997": 75, "00003": [75, 120], "56833156634588": 75, "54906255700261": 75, "99959": 75, "98314": 75, "02031": 75, "99696": 75, "97969": 75, "01686": 75, "00304": 75, "00041": [75, 81, 120], "47296765017848": 75, "99995": 75, "97129": 75, "02876": 75, "02871": 75, "97124": 75, "00005": [75, 99], "38059": [75, 90, 101], "468873e": 75, "091187e": 75, "83172": [75, 90, 101], "208787e": 75, "355741e": 75, "90237": [75, 90, 101], "045445e": 75, "623014e": 75, "729": 75, "708067912": 75, "739528252": 75, "740704223": 75, "740732582": 75, "740733616": 75, "740733655": 75, "740733657": 75, "11340211569278": 75, "98980": 75, "97263": 75, "97571": 75, "98356": 75, "00034": 75, "02409": 75, "00268": 75, "01544": [75, 124], "02279": 75, "01054": 75, "00046": 75, "00195": 75, "7351931372966": 75, "99830": 75, "99110": 75, "99600": 75, "99907": 75, "99382": 75, "01175": 75, "00118": 75, "00147": 75, "00444": 75, "00171": 75, "00035": 75, "00082": 75, "65407733183046": 75, "99450": 75, "99144": 75, "99900": 75, "01390": 75, "99166": 75, "00117": 75, "00153": 75, "00080": 75, "00149": 75, "00575": 75, "00047": 75, "64356171507335": 75, "99571": 75, "97554": 75, "12840": 75, "99582": 75, "86456": 75, "02646": 75, "00142": [75, 120], "00379": 75, "00507": 75, "00180": 75, "00051": 75, "00091": [75, 101], "55743398573296": 75, "99559": 75, "96489": 75, "02434": 75, "99775": 75, "03602": 75, "96813": 75, "00182": 75, "00191": 75, "00134": 75, "00164": 75, "00618": 75, "00039": 75, "29159": 75, "548866e": 75, "658376e": 75, "78501": 75, "247451e": 75, "355482e": 75, "12866": 75, "136810e": 75, "274229e": 75, "6329": 75, "787071882": 75, "791912542": 75, "792184181": 75, "792206026": 75, "792207797": 75, "792207936": 75, "792207948": 75, "792207950": 75, "11438963659845": 75, "98960": 75, "97168": 75, "97493": 75, "98327": 75, "02478": 75, "00289": 75, "01562": 75, "02338": 75, "01071": 75, "00060": 75, "00208": 75, "80003060665916": 75, "99159": 75, "97002": 75, "98187": 75, "99537": 75, "99592": 75, "03029": 75, "00318": 75, "00554": 75, "01330": 75, "00820": 75, "00236": 75, "00237": 75, "7189384955285": 75, "99111": 75, "97998": 75, "97319": 75, "03033": 75, "99427": 75, "00339": 75, "00552": 75, "00197": 75, "00953": 75, "01223": 75, "00311": 75, "70731804012333": 75, "98804": 75, "96044": 75, "12926": 75, "98430": 75, "86217": 75, "03726": 75, "01467": 75, "01016": 75, "00542": 75, "00348": 75, "00217": [75, 120, 143], "62036297238907": 75, "98665": 75, "95751": 75, "98540": 75, "04016": 75, "97604": 75, "00341": 75, "01331": 75, "00418": 75, "00547": 75, "01214": 75, "00187": 75, "55414": 75, "328951e": 75, "580239e": 75, "07698": 75, "154300e": 75, "705756e": 75, "44315": 75, "119484e": 75, "180816e": 75, "27763": 75, "793118310": 75, "798908867": 75, "799401560": 75, "799440899": 75, "799446125": 75, "799446623": 75, "799446711": 75, "799446734": 75, "799446738": 75, "799446739": 75, "12003281964508": 75, "98832": 75, "96820": 75, "97163": 75, "98078": 75, "00049": 75, "02805": 75, "00308": 75, "01801": [75, 120], "02650": 75, "01210": 75, "00062": 75, "00221": 75, "80828932732821": 75, "99041": 75, "96630": 75, "97922": 75, "99448": 75, "99598": 75, "03407": 75, "00351": 75, "00646": 75, "01523": 75, "00935": 75, "00243": 75, "00257": [75, 120], "72622990160039": 75, "98982": 75, "97785": [75, 124], "96971": 75, "99453": 75, "03391": 75, "99421": 75, "00372": 75, "00639": 75, "00215": 75, "01350": 75, "00324": 75, "7153774926884": 75, "98672": 75, "95763": 75, "14165": 75, "98172": 75, "84888": 75, "04031": 75, "00280": 75, "01710": 75, "01128": [75, 124, 151], "00608": 75, "00347": 75, "00235": 75, "62730415351615": 75, "98504": 75, "95735": 75, "01140": 75, "98291": 75, "04058": 75, "97774": 75, "00364": 75, "01556": 75, "00615": 75, "01336": 75, "00200": 75, "48297": 75, "323123e": 75, "607713e": 75, "01123": 75, "154562e": 75, "737591e": 75, "40783": 75, "150580e": 75, "218071e": 75, "38058973": 75, "30738694": 75, "83172339": 75, "90237127": 75, "monoton": 75, "unbal": 75, "accordin": 76, "omega_1": [76, 82, 83, 88, 91, 98, 117], "omega_2": [76, 82, 83, 88, 91, 98, 117], "omega_3": [76, 91], "eshg": 76, "eta": [76, 89, 91, 98], "thg": 76, "idri": 76, "rectif": [76, 98], "OR": [76, 98], "degener": [76, 91, 100, 122], "dfwm": 76, "perp": [76, 89, 98], "hyperpolarizabl": [76, 150], "signal": [76, 102, 142], "buffer": 76, "ultim": [76, 82], "analogi": 76, "zzz": [76, 83, 98], "zzzz": [76, 83], "3kt": [76, 89], "shg": [76, 98], "centrosymmetr": [76, 91], "molar": [76, 150], "n_a": [76, 150], "zxxz": 76, "xxz": 76, "10kt": 76, "avogadro": [76, 133, 150], "eop": [76, 98], "23538": 76, "statvolt": [76, 84, 91, 98], "esu": [76, 84, 91, 98], "omega_i": [76, 98], "cubicresponsedriv": [76, 83], "crf_drv": [76, 83], "a_oper": [76, 78, 83, 86, 88, 89, 98, 113], "b_oper": [76, 78, 83, 86, 88, 89, 98, 113], "c_oper": [76, 98], "d_oper": 76, "lrf": [76, 89, 98], "a_compon": [76, 78, 83, 86, 88, 89, 98, 113], "b_compon": [76, 78, 83, 86, 88, 89, 96, 98, 113], "c_compon": [76, 83, 98], "d_compon": [76, 83], "b_frequenc": [76, 83, 98], "0656": [76, 78, 88, 89, 98, 113, 156], "c_frequenc": [76, 83, 98], "d_frequenc": [76, 83], "004556": [76, 98], "crf_result": [76, 83], "556000e": [76, 98], "libxc": [76, 89, 98, 148], "lehtola": [76, 89, 98, 148], "steigemann": [76, 89, 98, 148], "oliveira": [76, 89, 98, 148], "marqu": [76, 89, 98, 148], "softwarex": [76, 89, 98, 148], "gerad": [76, 89, 98, 143, 148], "ungerad": [76, 89, 98, 143, 148], "28e": 76, "72e": 76, "46e": 76, "17e": 76, "crf": [76, 83], "998": [76, 101], "63439127": 76, "00000000j": [76, 89, 98], "1152": [76, 100, 156], "42872036": 76, "04492771j": 76, "w1": [76, 98], "w2": [76, 98], "w3": 76, "gamma_zzzz": 76, "6344": 76, "0000j": 76, "4287": 76, "0449j": 76, "conclud": [78, 143], "neon": [78, 141, 146, 157], "read_str": [78, 120, 153], "ne": [78, 143, 157], "lrf_drv": [78, 83, 88, 96], "result_str": 78, "lrf_result": [78, 83, 88, 89, 96], "lrf_length": 78, "lrf_veloc": 78, "837316": 78, "720512": 78, "362190": 78, "377629": 78, "augment": [78, 143, 144, 149], "mutual": [78, 82, 117], "multichromophor": 80, "chromophor": 80, "frenkel": [80, 94, 102, 105], "diabat": [80, 81], "monomer": 80, "le": [80, 81], "ct": [80, 81, 104, 105, 153], "l_b": 80, "l_bl_b": 80, "h_ah_a": 80, "h_al_b": 80, "ih_a": 80, "al_b": 80, "al_a": 80, "ih_b": 80, "h_bl_a": 80, "h_ah_b": 80, "l_bl_a": 80, "literatur": [80, 82], "c2h4": 81, "37731": 81, "01769": 81, "71611": 81, "04211": 81, "07142": 81, "72602": 81, "96225": 81, "74636": 81, "16458": 81, "90859": 81, "23094": 81, "24174": 81, "49049": 81, "84498": 81, "18262": 81, "54315": 81, "32947": 81, "25941": 81, "17537": 81, "48468": 81, "37427": 81, "06813": 81, "06658": 81, "62697": 81, "35657": 81, "40378": 81, "82687": 81, "92893": 81, "63558": 81, "29127": 81, "03527": 81, "90348": 81, "69157": 81, "24803": 81, "13578": 81, "15527": 81, "exmod_set": 81, "atoms_per_frag": 81, "ct_nocc": 81, "ct_nvir": 81, "method_set": [81, 100, 106, 113, 124, 131, 132, 142, 144, 148, 151, 153], "exmod_drv": 81, "excitonmodeldriv": 81, "monomer_natom": 81, "n_monom": 81, "monomer_start_indic": 81, "npair": 81, "total_le_st": 81, "total_ct_st": 81, "total_num_st": 81, "elec_trans_dipol": 81, "velo_trans_dipol": 81, "magn_trans_dipol": 81, "state_str": 81, "dimer_pair": 81, "inda": 81, "indb": 81, "excitation_id": 81, "get_excitation_id": 81, "monomers_info": 81, "get_sub_molecul": 81, "set_charg": [81, 120, 143, 144], "check_multipl": [81, 136], "monomer_scf": 81, "tda_result": [81, 115, 144], "monomer_tda": 81, "exc_energi": [81, 122], "exc_vector": 81, "one_elec_int": 81, "get_one_elec_integr": 81, "trans_dipol": 81, "get_le_trans_dipol": 81, "ind_a": 81, "monomer_a": 81, "ind_b": 81, "monomer_b": 81, "mo_a": 81, "mo_b": 81, "nocc_a": 81, "nocc_b": 81, "nvir_a": 81, "nvir_b": 81, "dimer_mo_coeffici": 81, "dimer_prop": 81, "dimer_properti": 81, "dimer_energi": 81, "exc_vectors_a": 81, "exc_vectors_b": 81, "dimer_excitation_vectors_le_a": 81, "dimer_excitation_vectors_le_b": 81, "dimer_excitation_vectors_ct_ab": 81, "dimer_excitation_vectors_ct_ba": 81, "c_vec": 81, "frag": 81, "sigma_vector": 81, "dimer_sigma_vector": 81, "get_ct_trans_dipol": 81, "i_vec": 81, "s_vec": 81, "30897": 81, "341337": 81, "344649": 81, "355572": 81, "375562": 81, "008184": 81, "000293": 81, "001344": 81, "000181": 81, "000038": 81, "000421": 81, "000136": 81, "000216": 81, "000076": 81, "000301": 81, "000065": 81, "000215": 81, "000057": 81, "001349": 81, "000075": 81, "000053": 81, "000226": 81, "014982": 81, "021419": 81, "00015": [81, 120], "00193": 81, "000318": 81, "002297": 81, "000302": 81, "002587": 81, "001974": 81, "309078": 81, "341401": 81, "344651": 81, "355577": 81, "375687": 81, "014984": 81, "000972": 81, "000351": 81, "001949": 81, "000333": 81, "002323": 81, "002045": 81, "002715": 81, "405391": 81, "000285": 81, "405247": 81, "5d": [81, 120], "eigvec": 81, "rotatory_strength": [81, 102, 105, 113], "dip_strength": 81, "87296": 81, "61775": 81, "1571": [81, 156], "28395": 81, "29395": 81, "0139": [81, 125, 153, 156], "37382": 81, "0007": [81, 156], "0213": [81, 156], "38091": 81, "0018": [81, 156], "s7": 81, "67239": 81, "0004": [81, 105, 156], "s8": 81, "67370": 81, "0028": [81, 156], "s9": 81, "20674": 81, "0108": [81, 125, 156], "s10": 81, "22814": 81, "0016": [81, 156], "0072": [81, 156], "s11": 81, "03968": 81, "0243": [81, 156], "0013": [81, 156], "s12": 81, "36147": 81, "0053": [81, 156], "0163": [81, 125, 156], "c_squar": 81, "xmin": [81, 106, 124, 125, 131, 142, 143, 144, 148, 151, 156], "xmax": [81, 106, 124, 125, 131, 142, 143, 144, 148, 151, 156], "xstep": [81, 106, 124, 125, 143, 144, 148, 151], "yi": [81, 106, 113, 124, 125, 142, 143, 144, 148, 151], "211385": 81, "y_ab": 81, "y_ecd": 81, "x_ref": 81, "29347889": 81, "31661749": 81, "33498928": 81, "33948716": 81, "34142481": 81, "34378921": 81, "35317567": 81, "35467501": 81, "37317654": 81, "37523192": 81, "38737236": 81, "38809457": 81, "40824740": 81, "41131899": 81, "44405319": 81, "44836638": 81, "45442440": 81, "45618961": 81, "45869117": 81, "46343516": 81, "46961985": 81, "47008569": 81, "48617428": 81, "48913889": 81, "49490201": 81, "49583015": 81, "49623637": 81, "50093006": 81, "50196948": 81, "50276614": 81, "54606024": 81, "54653988": 81, "54825489": 81, "54984647": 81, "55276288": 81, "55355450": 81, "56052689": 81, "56204114": 81, "56307883": 81, "56521540": 81, "57830505": 81, "57987938": 81, "58276149": 81, "59040369": 81, "59608911": 81, "59657872": 81, "60755394": 81, "61502897": 81, "62056515": 81, "62125169": 81, "y_abs_ref": 81, "0293": [81, 156], "1700": [81, 156], "0189": [81, 153, 156], "0008": [81, 156], "0003": [81, 156], "0036": [81, 156], "0011": [81, 156], "0076": [81, 156], "0042": [81, 156], "0170": [81, 156], "0268": [81, 156], "0055": [81, 156], "2073": 81, "7341": 81, "7807": 81, "8590": 81, "0543": [81, 156], "0794": [81, 156], "0043": [81, 156], "1701": 81, "0002": [81, 156], "0190": [81, 156], "4825": 81, "0609": [81, 156], "0031": [81, 156], "2050": [81, 156], "0191": [81, 153, 156], "0152": [81, 125, 153, 156], "y_ecd_ref": 81, "144750": 81, "164027": 81, "000035": 81, "014472": 81, "001995": 81, "004958": 81, "000899": 81, "019302": 81, "000786": 81, "013440": 81, "007686": 81, "000918": 81, "001135": 81, "000019": 81, "000222": 81, "003878": 81, "000392": 81, "000790": 81, "006479": 81, "047084": 81, "458896": 81, "154583": 81, "063050": 81, "217650": 81, "459211": 81, "383874": 81, "041366": 81, "032507": 81, "000123": 81, "000373": 81, "025144": 81, "050821": 81, "000443": 81, "003195": 81, "001069": 81, "000036": 81, "285024": 81, "269169": 81, "004591": 81, "000050": 81, "005488": 81, "001347": 81, "000665": 81, "000083": 81, "023592": 81, "011323": 81, "x0_ref": 81, "y0_ref": 81, "x1_ref": 81, "y1_ref": 81, "euler": 82, "cosin": 82, "einstein": [82, 88, 91], "lambda_1": [82, 94, 117], "lambda_n": 82, "rotation": 82, "e_z": 82, "lambda_2": [82, 94, 117], "control": [82, 128, 142], "solenoid": 82, "monochromat": [82, 99, 111, 117, 129], "lp": 82, "137": [82, 98, 124, 125, 142, 144, 150, 156], "cp": 82, "instant": 82, "helix": 82, "clockwis": 82, "bed": 82, "mj": 82, "puls": [82, 144], "durat": 82, "mathsf": 82, "gw": [82, 111], "damag": [82, 144], "nonvanish": [82, 91], "subtract": [82, 113], "sum_l": 82, "sum_m": 82, "multipolar": 82, "tensori": 82, "ex": [82, 91], "sake": 82, "symplic": 82, "quadrupol": [82, 91, 102, 150], "popolar": 82, "traceless": [82, 84], "concentr": 82, "imping": [82, 91], "rigidli": 82, "loss": 82, "e_x": [82, 144], "enclos": 82, "parenthes": 82, "swap": 82, "i_3": 82, "wagni\u00e8r": 82, "av": 82, "reintroduc": [82, 144], "gather": [82, 96], "pseudoscalar": 82, "rigor": 82, "detector": 82, "transvers": 82, "albeit": [82, 122, 142, 144, 149], "ecd": 82, "lk": 82, "reassoci": 82, "front": [82, 94], "conterpart": 82, "assembli": [82, 142], "absorb": [82, 91, 117, 130, 142, 144], "uniform": [83, 96], "slower": 83, "polarizabilti": 83, "qrf_drv": [83, 98], "quadraticresponsedriv": [83, 98], "numerical_deriv": 83, "d2": 83, "hyperpolarizaibl": 83, "qrf_result": [83, 98], "qrf": [83, 98], "dmu": 83, "dalpha": 83, "dbeta": 83, "nnumer": 83, "744762": 83, "34779": 83, "73492": 83, "744763": 83, "71224": 83, "1047": [83, 156], "34781": 83, "73532": 83, "73499": 83, "151": 83, "theta_": [84, 91], "2n": [84, 91, 113, 136], "tabul": 84, "octupol": 84, "hexadecapol": 84, "unambigu": 84, "bf": 84, "obvious": 84, "z_": [84, 88, 94, 96], "fold": [84, 100], "ge": 84, "47835": 84, "5417": [84, 91], "48655": 84, "3450": [84, 91], "stavolt": 84, "invit": 86, "z_n": 86, "kappa_n": 86, "g_m": 86, "dagger_j": 86, "dagger_a": [86, 90], "0_j": 86, "0_i": [86, 113], "0_": 86, "ethylene_xyz": [88, 96], "67759997": [88, 94, 96, 102, 105, 113, 115], "21655197": [88, 94, 96, 102, 105, 113, 115], "92414474": [88, 94, 96, 102, 105, 113, 115], "mu_x_ao": 88, "get_full_vector": [86, 88, 96], "23248623e": [], "91519961e": [], "69416713e": [], "64234609e": [], "89579507e": [], "06669079e": [], "28920938e": [], "28266220e": [], "44677557e": [], "11076999e": [], "domain": 88, "sinusoid": 88, "omega_0": 88, "2i": [88, 100], "cetera": 88, "omega_x": 88, "f_x": [88, 96], "thought": [88, 97, 99], "normalz": 88, "whatev": 88, "recognit": 88, "minu": [88, 99, 111, 113, 143], "vector_to_matrix": 88, "zymat": 88, "expectation_valu": 88, "alpha_xx": [88, 113], "84380178": 88, "interpret": [89, 142, 150], "darwin": 89, "iso": 89, "macroscop": [89, 91, 98], "permitt": [89, 91, 150], "permeabl": [89, 150], "electrodynam": 89, "ill": [89, 111, 144], "slowli": [89, 108], "nondipolar": 89, "quantit": [89, 153], "birefring": 89, "hyper": 89, "2k": 89, "01161246": 89, "19770107": 89, "20248108": 89, "18863810": 89, "53971511": 89, "31867382": 89, "64430453": 89, "31469367": 89, "46320379": 89, "84501162": 89, "57203409": 89, "83255985": 89, "09615293": 89, "02138969": 89, "29211162": 89, "02009095": 89, "73585054": 89, "04219749": 89, "84454457": 89, "04171911": 89, "31931552": 89, "11162972": 89, "45876238": 89, "11004217": 89, "09692448": 89, "00083876": 89, "29287459": 89, "00078245": 89, "73799055": 89, "00264362": 89, "84673034": 89, "00268306": 89, "34755032": 89, "01367302": 89, "48835616": 89, "01341692": 89, "56e": 89, "09692566": 89, "00005136": 89, "29287577": 89, "00005883": 89, "73800472": 89, "00017941": 89, "84674589": 89, "00018212": 89, "34779283": 89, "00065565": 89, "48860561": 89, "00064486": 89, "73800476": 89, "00000564": 89, "84674594": 89, "00000865": 89, "34779352": 89, "00003494": 89, "48860634": 89, "00003797": 89, "comp": 89, "096926": 89, "yx": [89, 142], "zx": 89, "292876": 89, "738005": 89, "zy": 89, "846746": 89, "347794": 89, "488606": 89, "complexrespons": [89, 113], "00454": [89, 120], "46269350": 89, "84498224": 89, "57145838": 89, "01536178j": 89, "83253311": 89, "31865693": 89, "11164275": 89, "45878685": 89, "01990331j": 89, "10876894": 89, "34689234": 89, "01367735": 89, "48759482": 89, "01998091j": 89, "01336083": 89, "48e": 89, "34713524": 89, "00054764": 89, "48784349": 89, "01998114j": 89, "00053700": 89, "34713579": 89, "00002708": 89, "48784407": 89, "00003524": 89, "347136": 89, "000000j": [89, 98], "487844": 89, "019981j": 89, "altogeth": 90, "unocc": [90, 94, 111], "0n": [90, 117], "o_2p": [90, 101, 124], "991312026": 90, "006166338": 90, "032227092": 90, "034907536": 90, "037509034": 90, "037708221": 90, "037802925": 90, "037839963": 90, "037842633": 90, "037843292": 90, "037843330": 90, "037843340": 90, "037843341": [90, 101], "0378433408259": 90, "99931": [90, 101], "97806": [90, 101], "97495": [90, 101], "02400": [90, 101], "02368": [90, 101], "55485": [90, 101], "07299": 90, "50217": 90, "83591": 90, "975": [90, 101, 124], "70221": 90, "75289": 90, "73042": 90, "68038": 90, "78478": 90, "981834": 90, "495574": 90, "mcrpa": [90, 124], "mclr_eigensolv": [90, 124], "rsp_dict": [90, 153], "mc": [90, 124], "647019008": 90, "513232268": 90, "473594122": 90, "458084076": 90, "453452539": 90, "452548808": 90, "452313010": 90, "452201613": 90, "452196083": 90, "452191087": 90, "452190945": 90, "452190916": 90, "452190914": 90, "3310434": 90, "00815": 90, "0389358": 90, "0122841": 90, "4090433": 90, "13064": 90, "0000000": [90, 124], "4311622": 90, "73252": 90, "1736409": 90, "1284413": 90, "5113197": 90, "91372": 90, "1444330": 90, "1449627": 90, "5783860": 90, "73868": 90, "3471652": 90, "4072428": 90, "fci_excitation_energi": [90, 101], "68451": [90, 101], "cis_excitation_energi": [90, 101], "30739": [90, 101], "casci_excitation_energi": 90, "61974291": 90, "73087038": 90, "61579239": 90, "51654574": 90, "sa_casscf_excitation_energi": 90, "55787583": 90, "83566209": 90, "32868402": 90, "56323891": 90, "mcrpa_6_5_excitation_energi": 90, "00814853": 90, "1306361": 90, "73252108": 90, "91371718": 90, "get_excitation_charact": 90, "33104335562552106": 90, "391": 90, "574": 90, "616": 90, "384": 90, "40904333562087525": 90, "664": 90, "700": 90, "4311622010138693": 90, "207": [90, 150, 156], "332": 90, "335": 90, "665": 90, "5113196797605539": 90, "215": 90, "106": [90, 156], "386": 90, "415": [90, 136], "585": 90, "5783859960264529": 90, "519": [90, 144], "459": 90, "broadli": [90, 103], "sizeabl": 90, "perfectli": 90, "037271082": 90, "037273353": 90, "037273800": 90, "037273988": 90, "037274022": 90, "037274031": [90, 124], "037274032": [90, 124], "03727403201918": 90, "97794": [90, 124], "97490": [90, 124], "02386": [90, 124], "02330": [90, 124], "55475": 90, "07554": 90, "50212": [90, 124], "83330": 90, "70218": 90, "75294": 90, "73232": 90, "67760": 90, "78416": 90, "16377": [90, 124], "983159": 90, "498941": 90, "710067027": 90, "504433348": 90, "460454267": 90, "438804358": 90, "436938061": 90, "423456314": 90, "421352332": 90, "420272535": 90, "420217560": 90, "420204856": 90, "420204685": 90, "420204669": 90, "3305288": 90, "99415": 90, "0389580": 90, "0121777": [90, 124], "4084609": 90, "11479": 90, "4307468": 90, "72122": 90, "1738542": 90, "1284536": 90, "5110821": 90, "90725": 90, "1450310": 90, "1453630": 90, "mcrpa_4_4_excitation_energi": 90, "99414655": 90, "11478813": 90, "7212186": 90, "90725253": 90, "3305287922814632": 90, "4084609334794776": 90, "670": 90, "43074684235636357": 90, "281": 90, "205": 90, "5110821086027035": 90, "221": [90, 124, 143, 144], "216": 90, "388": 90, "583": 90, "invok": 90, "modest": 90, "damcoff": 90, "710192193": 90, "505688090": 90, "467941118": 90, "447283455": 90, "445599132": 90, "434442055": 90, "432814242": 90, "431128477": 90, "430925260": 90, "430911781": 90, "430909612": 90, "430909517": 90, "430909448": 90, "430909446": 90, "3459460": 90, "41367": 90, "0403367": 90, "0142157": 90, "4209258": 90, "45397": 90, "4376907": 90, "91017": 90, "1841986": 90, "1222064": 90, "5190753": 90, "12476": 90, "1187446": 90, "1440273": 90, "mctda_4_4_excitation_energi": 90, "41366984": 90, "45397333": 90, "9101715": 90, "12475838": 90, "vacuo": 91, "axial": 91, "nabla_": 91, "xi_": 91, "eta_": 91, "hypermagnetiz": 91, "classif": 91, "tie": 91, "prime_": 91, "prime": [91, 100], "incom": [91, 98, 129, 142, 144], "outgo": [91, 129, 144], "ward": 91, "r_i": 91, "omega_j": 91, "outcom": 91, "diamagnet": 91, "suscept": 91, "dia": 91, "2m_i": 91, "p_i": 91, "birss": 91, "cite": 91, "birr": 91, "characterist": [91, 150], "examin": [91, 122], "summar": [91, 125], "paragraph": 91, "po": 91, "ae": 91, "appar": [91, 143], "thumb": 91, "prescript": 91, "therein": [91, 136], "cf": [91, 133, 144], "6mm": 91, "mmm": 91, "m3m": 91, "simplif": 91, "bulk": 91, "104206": 91, "vm": 91, "7153": 91, "478353": 91, "486551": 91, "648777": 91, "4818": 91, "206362": 91, "6392": [91, 98], "235381": 91, "formaldehyd": [92, 143], "chemi": 92, "bio": 92, "luminesc": 92, "moieti": 92, "snapshot": [92, 157], "dioxetane_xyz": 92, "competit": 92, "formaldehyde_str": 92, "08516846": 92, "12131123": 92, "93777476": 92, "71598634": 92, "settl": 92, "messag": 92, "td": [92, 122], "troubl": [92, 101], "photochemistri": 93, "repsect": 94, "t_f": 94, "z_f": 94, "y_f": 94, "integrand": 94, "singular": [94, 143], "svd": 94, "bright": [94, 102], "s_2": 94, "lreig_drv": [94, 102, 105], "linearresponseeigensolv": [86, 94, 102, 105, 106, 113, 115, 124, 144, 148, 151, 153], "nto_cub": [94, 153], "lreig_result": [94, 102, 105], "nto_lambda": 94, "72499013e": 94, "72475474e": 94, "29239846e": 94, "29211293e": 94, "24552557e": 94, "24323138e": 94, "88180541e": 94, "88178172e": 94, "99380768e": 94, "99361419e": 94, "04378289e": 94, "04255915e": 94, "28944812e": 94, "28167411e": 94, "18819618e": 94, "17971235e": 94, "nto_h5_fil": [94, 153], "576": 94, "xf": [94, 106, 113, 148], "eigenvectors_distribut": [94, 113], "zf": 94, "yf": 94, "exponenti": [96, 97], "shall": 96, "lr": 96, "mobil": 96, "redistribut": 96, "0_x": 96, "s_field": 96, "c_field": 96, "pylab": 96, "_1e": 97, "_2e": 97, "_ne": 97, "_pe": 97, "rp": 97, "overbar": 97, "k31": 97, "k32": 97, "k41": 97, "k42": 97, "5j": 97, "k13": 97, "k23": 97, "k14": 97, "k24": 97, "1j": [86, 97, 99], "20240208": 97, "414314": 97, "272098": 97, "000049j": 97, "063249": 97, "357053j": 97, "609038": 97, "501889j": 97, "784682": 97, "400653": 97, "136519j": 97, "138307": 97, "334586j": 97, "78434": 97, "265899": 97, "058835j": 97, "414656": 97, "25j": 97, "707107": 97, "psi_3": 97, "psi_4": 97, "k51": 97, "k61": 97, "k52": 97, "k62": 97, "k15": 97, "k16": 97, "k25": 97, "k26": 97, "195145": 97, "674738": 97, "007566j": 97, "272185": 97, "364692j": 97, "150157": 97, "219078j": 97, "077445": 97, "261337j": 97, "390656": 97, "045347j": 97, "pockel": 98, "kleinman": 98, "satur": 98, "pluta": 98, "proven": 98, "face": 98, "20636": 98, "1312": [98, 156], "44e": 98, "16e": 98, "165": 98, "73136841": 98, "98788527": 98, "24601088j": 98, "04348163": 98, "22700923j": 98, "beta_zzz": 98, "731368": 98, "987885": 98, "246011j": 98, "043482": 98, "227009j": 98, "weaker": [99, 111, 120, 143, 144], "encompass": [99, 111], "vast": [99, 111], "overwhelm": [99, 111], "erf": [99, 111], "schr\u00f6inger": 99, "evolut": [99, 111], "fw": 99, "eb": 99, "muab": 99, "muba": 99, "neglig": [99, 100, 143, 144], "alpha_numer": 99, "eba": 99, "alpha_analyt": 99, "wb": 99, "alpha_wa": 99, "alpha_wb": 99, "vline": 99, "headwidth": 99, "headlength": 99, "diatom": [100, 103, 143], "dfrac": 100, "m_b": 100, "speric": 100, "y_j": 100, "e_j": 100, "2j": 100, "branch": 100, "equidist": 100, "x_a": 100, "x_b": 100, "pick": 100, "forbidden": [100, 102, 141], "accept": 100, "renew": 100, "hcl": 100, "cl": [100, 131], "scf_set": [100, 106, 124, 131, 142, 144, 148, 151, 153], "11p": 100, "num_drv": 100, "numerovdriv": 100, "pec_displac": 100, "pec": 100, "pec_potenti": 100, "el_transit": 100, "boolean": 100, "final_el_st": 100, "exc_conv_thresh": 100, "n_vib_stat": 100, "temp": 100, "kelvin": [100, 150], "n_rot_stat": 100, "n_margin": 100, "p_margin": 100, "steps_per_au": 100, "numerov_set": 100, "num_result": 100, "convergec": 100, "ang": 100, "85540": 100, "2211": [100, 156], "16191": 100, "3269": 100, "13406": 100, "5386": 100, "42849": 100, "6444": 100, "80534": [100, 101], "7503": 100, "21628": 100, "174": 100, "166": 100, "2615": [100, 156], "94747e": 100, "44302e": 100, "2576": 100, "73425e": 100, "2556": 100, "04621e": 100, "2536": [100, 156], "83968e": 100, "2517": 100, "56958e": 100, "2497": [100, 156], "52708e": 100, "2478": 100, "10791e": 100, "2458": [100, 156], "86134e": 100, "2635": 100, "86084e": 100, "2654": 100, "37859e": 100, "2674": 100, "76177e": 100, "2694": 100, "18696e": 100, "2713": 100, "46448e": 100, "2733": 100, "80881e": 100, "2752": 100, "65905e": 100, "2772": 100, "44870e": 100, "2792": 100, "45524e": 100, "2811": 100, "72649e": 100, "2831": 100, "67969e": 100, "vib_level": 100, "vib_psi2": 100, "vib_energi": 100, "psi2": 100, "fi": 100, "rigid": [100, 149], "rotor": 100, "frank": 100, "herzberg": 100, "teller": 100, "exict": 100, "00371": 100, "18856": 100, "77836": 100, "68682": 100, "83574": 100, "11225": 100, "28673": 100, "139": [100, 156], "78431": 100, "62970e": 100, "80560": 100, "18422e": 100, "82592": 100, "98800e": 100, "75795": 100, "01134e": 100, "73268": 100, "47555e": 100, "i_potenti": 100, "i_psi": 100, "i_vib_level": 100, "f_potenti": 100, "f_psi": 100, "f_vib_level": 100, "de_elec": 100, "pec_energi": 100, "gs_potenti": 100, "gs_vib_psi2": 100, "gs_vib_energi": 100, "es_potenti": 100, "es_vib_psi2": 100, "es_vib_energi": 100, "gs_energi": 100, "es_energi": 100, "read_pec_data": 100, "bond_length": 100, "tmom": 100, "trans_moment": 100, "set_reduced_mass": 100, "194": [100, 156], "193": [100, 136], "191": 100, "187": [100, 144], "195": 100, "173": 100, "171": 100, "43314": 100, "67445e": 100, "46035": 100, "61293e": 100, "48755": 100, "10780e": 100, "51475": 100, "17810e": 100, "54195": 100, "08405e": 100, "56916": 100, "34778e": 100, "59636": 100, "89534e": 100, "62356": 100, "04635e": 100, "65076": 100, "20261e": 100, "67796": 100, "94669e": 100, "39983": 100, "56212e": 100, "36651": 100, "98373e": 100, "33320": 100, "60179e": 100, "29988": 100, "18635e": 100, "26656": 100, "19878e": 100, "23325": 100, "02682e": 100, "19993": 100, "61992e": 100, "16662": 100, "95672e": 100, "13330": 100, "83167e": 100, "gs_psi2": 100, "es_psi2": 100, "ll": 101, "62002504": 101, "73138794": 101, "61624803": 101, "51670672": 101, "imbal": 101, "n_th": 101, "e1": 101, "03784334097188": 101, "07301": 101, "50216": 101, "83590": 101, "70220": 101, "75290": 101, "73044": 101, "68036": 101, "78476": 101, "981835": 101, "495575": 101, "353559469": 101, "593571375": 101, "632461251": 101, "642345169": 101, "642439232": 101, "642461616": 101, "642463966": 101, "642464740": 101, "642464800": 101, "642464810": 101, "642464811": 101, "99867538836281": 101, "98064": 101, "98062": 101, "01721": 101, "99899": 101, "02255": 101, "6424648114672": 101, "99396": 101, "97991": 101, "02521": 101, "71709": 101, "18832": 101, "84981": 101, "980": 101, "98576": 101, "12396": 101, "35135": 101, "52545": 101, "73663": 101, "99710": 101, "878313": 101, "232449": 101, "001754": 101, "004459": 101, "2nd": [101, 150], "7588": 101, "6845": 101, "hinder": 101, "broader": 101, "gap": [101, 113, 122, 124, 126], "349459644": 101, "357346944": 101, "498295478": 101, "612871787": 101, "623966139": 101, "624835693": 101, "612659551": 101, "621464196": 101, "624429113": 101, "629064929": 101, "630931527": 101, "631869670": 101, "634998565": 101, "474779653": 101, "559709493": 101, "636134037": 101, "632576587": 101, "628217000": 101, "634720590": 101, "637351866": 101, "624461265": 101, "631750868": 101, "632562481": 101, "636046647": 101, "636930293": 101, "637342129": 101, "631279519": 101, "635720026": 101, "636480515": 101, "636878803": 101, "637497423": 101, "637695019": 101, "637847521": 101, "626206234": 101, "629362438": 101, "634231718": 101, "636493139": 101, "637385781": 101, "636852565": 101, "637628176": 101, "637786548": 101, "637881310": 101, "633537870": 101, "636485156": 101, "637558801": 101, "637513189": 101, "637729900": 101, "637880391": 101, "637887967": 101, "637945853": 101, "99248196219575": 101, "99882": 101, "98031": 101, "97980": 101, "01802": 101, "02306": 101, "64016061987452": 101, "99577": 101, "97809": 101, "02452": 101, "00161": 101, "63794585280809": 101, "98067": 101, "99160": [101, 124], "99806": 101, "02967": 101, "72399": 101, "21935": 101, "35489": 101, "95695": 101, "85270": 101, "12384": 101, "030": [101, 113], "25400": 101, "98349": 101, "00141": 101, "027719": 101, "070456": 101, "821550": 101, "088171": 101, "822017": 101, "089359": 101, "020799": 101, "052865": 101, "037923": 101, "096390": 101, "043252": 101, "109936": 101, "057847": 101, "147033": 101, "011887": 101, "030215": 101, "059056": 101, "150106": 101, "cumbersom": [101, 142], "betweem": 101, "compromis": [101, 124], "55787634": 101, "83565758": 101, "32867792": 101, "56323052": 101, "deterior": [101, 144], "first_exc_energi": 101, "843270570": 101, "858829181": 101, "864455914": 101, "864858793": 101, "864894174": 101, "864897105": 101, "864897238": 101, "864897243": 101, "01351106935542": 101, "98571": 101, "97737": 101, "99925": 101, "01512": 101, "02254": 101, "71628341721825": 101, "99623": 101, "97627": 101, "00146": 101, "02604": 101, "64857": 101, "19270": 101, "985": 101, "86834": 101, "973": 101, "76522": 101, "43591": 101, "515": [101, 113, 144], "12362": 101, "60891": 101, "84500": 101, "10548": 101, "914415": 101, "324211": 101, "066692": 101, "169513": 101, "08798": 101, "153103e": 101, "791691e": 101, "724068655": 101, "725200119": 101, "725331151": 101, "725334435": 101, "725334997": 101, "725335073": 101, "725335090": 101, "00986341043273": 101, "98623": 101, "97762": 101, "01412": 101, "02272": 101, "71760513688903": 101, "99620": 101, "97731": 101, "00100": 101, "02548": 101, "4485367237144": 101, "99442": 101, "99771": 101, "00266": 101, "00751": 101, "66135": 101, "25118": 101, "988": 101, "84539": 101, "666": [101, 124, 151], "50141": 101, "648": [101, 125], "70435": 101, "675": 101, "08480": 101, "55591": 101, "84550": 101, "08882": 101, "902880": 101, "294892": 101, "071924": 101, "182813": 101, "220125": 101, "559501": 101, "95275": 101, "899035e": 101, "003629e": 101, "27448": 101, "502994e": 101, "169096e": 101, "650642982": 101, "692220117": 101, "694350449": 101, "694439713": 101, "694445644": 101, "694446718": 101, "694446789": 101, "694446804": 101, "99698121055799": 101, "98702": 101, "98210": 101, "99942": 101, "01415": 101, "01731": 101, "70831745311033": 101, "99704": 101, "98460": 101, "00024": [101, 120], "62405336905468": 101, "98743": 101, "99379": 101, "02056": 101, "99822": 101, "44843518488997": 101, "99702": 101, "00111": 101, "99835": 101, "99825": 101, "00526": 101, "67802": 101, "24525": 101, "87394": 101, "734": 101, "74018": 101, "499": 101, "46605": 101, "512": [101, 144], "10271": 101, "267": [101, 156], "23802": 101, "99722": 101, "08042": 101, "865079": 101, "198812": 101, "085985": 101, "218553": 101, "042742": 101, "108641": 101, "237138": 101, "602745": 101, "85494": 101, "812051e": 101, "149862e": 101, "92670": 101, "583994e": 101, "096522e": 101, "630250704": 101, "672532115": 101, "683260739": 101, "686039130": 101, "686051087": 101, "686051424": 101, "686051445": 101, "98214396906145": 101, "98461": 101, "99145": 101, "99958": 101, "01560": 101, "00875": 101, "70439717084962": 101, "98783": 101, "01582": 101, "99913": 101, "62069022907059": 101, "99499": 101, "99411": 101, "99764": 101, "01326": 101, "60257216026255": 101, "96066": 101, "22366": 101, "99968": 101, "04213": 101, "77386": 101, "52045369603377": 101, "97487": 101, "01895": 101, "99956": 101, "97610": 101, "03052": 101, "68941": 101, "44678": 101, "976": 101, "604": [101, 144, 156], "58138": 101, "50270": 101, "414": 101, "21172": 101, "406": 101, "11950": 101, "00726": 101, "07263": 101, "847570": 101, "154309": 101, "071706": 101, "182257": 101, "023140": 101, "058815": 101, "110856": 101, "281768": 101, "135447": 101, "344272": 101, "55788": 101, "182600e": 101, "629917e": 101, "32868": 101, "101141e": 101, "302122e": 101, "56323": 101, "491871e": 101, "439096e": 101, "deteriot": 101, "degrad": 101, "undesir": 101, "modulu": 102, "2h": 102, "frontier": [102, 148], "slight": 102, "supramolecular": 102, "pi_1": 102, "pi_2": 102, "capit": 102, "1b_": 102, "electric_transition_dipol": [102, 105, 113, 124, 151], "magnetic_transition_dipol": [102, 105, 113], "2114": [102, 105, 106, 113, 115, 144, 148, 156], "5915": [102, 105], "9272": 102, "2471": [102, 105, 156], "6703": 102, "5637": 102, "4311": [102, 105], "9185": 102, "1743": 102, "7460": [102, 105, 143], "4909": 102, "band": 102, "acquir": 102, "bisign": 102, "microwav": 103, "thorough": 104, "zcoord": 105, "underestim": [105, 128, 143], "3348": 105, "6384": 105, "7892": 105, "8796": 105, "1239": 105, "1364": 105, "1403": [105, 156], "1582": [105, 156], "1462": [105, 156], "1434": [105, 156], "1424": [105, 156], "1910": [105, 156], "1955": [105, 156], "2069": 105, "2095": 105, "2104": [105, 156], "3491": 105, "2266": [105, 156], "2157": [105, 156], "2123": 105, "8032": [105, 156], "1899": 105, "3113": 105, "3716": 105, "4077": 105, "6507": 105, "cell": [105, 147], "detach_attach": [105, 153], "dimer_20a": 105, "9598": 105, "0065": [105, 156], "8031": 105, "5360": 105, "0214": [105, 125, 156], "exc_str": 105, "excitation_detail": [105, 113], "orb_str": 105, "5030": 105, "4914": 105, "6399": 105, "2917": 105, "5896": 105, "5668": [105, 156], "4108": 105, "3954": 105, "5959": 105, "5734": 105, "4015": 105, "3858": 105, "8128": 105, "5566": 105, "8125": 105, "5570": 105, "valet": [105, 113, 153], "subgroup": [105, 153], "ampli": 105, "transition_analysis_util": [105, 113, 153], "subgroup_nam": [105, 153], "atom_subgroup_map": [105, 153], "plot_transition_diagram": [105, 153], "state_index": [105, 153], "density_type_plu": [105, 153], "density_type_minu": [105, 153], "hole_cub": [105, 153], "particle_cub": [105, 153], "load_transit": [105, 153], "segment_arrai": [105, 153], "compute_atomic_charg": [105, 153], "subgroup_info": [105, 153], "subgroupinfo": [105, 153], "set_subgroup": [105, 153], "compute_subgroup_charg": [105, 153], "diagram_titl": [105, 153], "create_diagram": [105, 153], "save_plot": [105, 153], "allevi": 106, "vlx_mol": [106, 148], "vlx_ba": [106, 148], "lr_eig_solv": [106, 148], "lr_solver": [106, 148], "e2": [86, 106, 113, 115, 148], "get_e2": [86, 106, 113, 115, 148], "v1_x": [106, 148], "v1_y": [106, 148], "v1_z": [106, 148], "get_prop_grad": [86, 106, 113, 148], "sinv": [106, 148], "clariti": [106, 148], "fosc": [106, 113, 148], "tm": [106, 113, 124, 148, 149, 151], "res_mo": 106, "res_indx": 106, "deexcit": 106, "c_int_deex": 106, "e2_cv": 106, "s2_cv": 106, "v1_cvs_x": 106, "v1_cvs_y": 106, "v1_cvs_z": 106, "eigs_cv": 106, "x_cv": 106, "fosc_cv": 106, "xf_cv": 106, "tm_cv": 106, "core_excit": [106, 144, 148], "num_core_orbit": [106, 144, 148], "o1": [106, 142], "vlx_cvs_result": [106, 148], "525": [106, 144, 148], "x10": [106, 148], "siplifi": 108, "futil": 108, "seldom": 109, "tractabl": 109, "met": 111, "seek": 111, "secondari": 111, "ehrenfest": 111, "histor": 113, "ethene_xyz": [113, 115, 131, 133], "from_xyz_str": [113, 115, 153], "nmo": 113, "nhomo": 113, "2318428": 113, "23036306": 113, "03031426": 113, "79297209": 113, "64755459": 113, "57527959": 113, "51027799": 113, "3664635": 113, "17010963": 113, "26253257": 113, "29520837": 113, "31109777": 113, "38857996": 113, "47929591": 113, "68491581": 113, "78814557": 113, "78870971": 113, "8870793": 113, "89030532": 113, "97978752": 113, "15705815": 113, "20987525": 113, "2392286": 113, "2517033": 113, "36026403": 113, "54571226": 113, "lres_drv": [86, 113, 115], "rsp_set": 113, "lres_out": 113, "velocity_transition_dipol": 113, "print_tabl": 113, "lre": 113, "933": 113, "45586": 113, "53151": 113, "00012": 113, "02174": 113, "461": 113, "629": 113, "858": 113, "538": [113, 144, 145], "589": 113, "919": 113, "72579": 113, "40916": 113, "11817": 113, "74133": 113, "5pt": 113, "20pt": 113, "10pt": 113, "25pt": 113, "dim": [86, 113], "imshow": 113, "colorbar": 113, "361149": 113, "isi": 113, "phys_ovov": 113, "iiss": 113, "diag_el": 113, "15pt": 113, "v1x": 113, "v1y": 113, "v1z": 113, "vmtrx": 113, "vx": 113, "vmin": 113, "vmax": 113, "vy": 113, "133": [113, 150, 156], "vz": 113, "005214": 113, "dipole_matric": [113, 144], "x_ao": [113, 144], "x_mo": [113, 144], "_e": 113, "9pt": 113, "3pt": 113, "nonsingular": 113, "8pt": 113, "emphas": 113, "29153356": 113, "35199506": 113, "36380664": 113, "36860999": 113, "38443182": 113, "42735114": 113, "47252353": 113, "49752266": 113, "4993755": 113, "54458488": 113, "54825333": 113, "55314321": 113, "dagger_f": 113, "compute_fosc": 113, "nrefer": 113, "558630e": 113, "000000e": 113, "160000e": 113, "257950e": 113, "118172e": 113, "55864e": 113, "00000e": 113, "16000e": 113, "25793e": 113, "11817e": 113, "9893": [113, 156], "9782": 113, "9966": 113, "9766": 113, "9895": 113, "9691": 113, "9710": 113, "2150": 113, "9591": [113, 153], "2531": 113, "9904": 113, "9684": 113, "8945": 113, "3767": 113, "sought": [113, 133], "funciton": 113, "dictonari": 113, "alpha_yi": 113, "alpha_zz": 113, "985929": 113, "268122": 113, "201365": 113, "nx": 113, "ny": 113, "nz": 113, "018986": 113, "491345": 113, "244817": 113, "phenomenolog": 113, "sound": 113, "nonreson": 113, "kramer": 113, "kronig": 113, "cpp_drv": [113, 124, 144], "cpp_out": 113, "yr": 113, "57868869": 115, "00818369": 115, "22485575": 115, "60189688": 115, "76762482": 115, "tdaexcidriv": [115, 122], "tda_drv": [115, 144], "57868811": 115, "00818379": 115, "22485652": 115, "60189672": 115, "76762549": 115, "tpa": 117, "sf": 117, "0m": 117, "m0": 117, "colour": 117, "nonvari": 117, "aristotl": 119, "bohr_to_\u00e5": 120, "eq_molecul": 120, "eq_orbit": 120, "eq_2dens": 120, "499278403420": 120, "00000005": 120, "00000003": [120, 143, 148], "4992784034": 120, "0000000462": 120, "7500": 120, "49928": 120, "57244": 120, "44303": 120, "07335": 120, "75329": 120, "57364": 120, "0583544218": 120, "044195881437": 120, "048687184260": 120, "03228141": 120, "00976213": 120, "048800398179": 120, "0001132139": 120, "00075218": 120, "00019687": 120, "00838820": 120, "048800556215": 120, "0000001580": 120, "00000986": 120, "00000323": 120, "00041723": 120, "048800556227": 120, "00000326": 120, "0488005562": 120, "1071549780": 120, "0000000051": 120, "67746": 120, "23819": 120, "42154": 120, "16876": 120, "33275": 120, "079370051": 120, "0793700508928035": 120, "97719": 120, "00008": 120, "00501": 120, "00970": 120, "00380": 120, "00013": 120, "8819620182": 120, "102601746873": 120, "106788495584": 120, "03045659": 120, "00841139": 120, "106892338747": 120, "0001038432": 120, "00069812": 120, "00020665": 120, "00725834": 120, "106892475138": 120, "0000001364": 120, "00000920": 120, "00000317": 120, "00039011": 120, "106892475152": 120, "00000386": 120, "1068924752": 120, "9888544933": 120, "0000000057": 120, "63879": 120, "22260": 120, "44547": 120, "05754": 120, "31355": 120, "139173293": 120, "1391732932951475": 120, "97340": 120, "00564": 120, "00016": 120, "00011": 120, "7559674441": 120, "122770998276": 120, "126826026762": 120, "02918562": 120, "00724027": 120, "126924576362": 120, "0000985496": 120, "00064391": 120, "00020404": 120, "00640409": 120, "126924692283": 120, "0000001159": 120, "00000970": 120, "00000342": 120, "00036324": 120, "126924692303": 120, "00000477": 120, "1269246923": 120, "8828921364": 120, "0000000192": 120, "60482": 120, "20498": 120, "46968": 120, "96759": 120, "29782": 120, "160904682": 120, "1609046824806657": 120, "96871": 120, "00602": 120, "00331": 120, "00019": 120, "00014": 120, "7055696145": 120, "124608367719": 120, "128645660151": 120, "02872496": 120, "00752087": 120, "128743027026": 120, "0000973669": 120, "00062088": 120, "00020101": 120, "00607432": 120, "128743134729": 120, "0000001077": 120, "00001024": 120, "00000362": 120, "00035226": 120, "128743134753": 120, "00000526": 120, "1287431348": 120, "8343127493": 120, "0000000210": 120, "58941": 120, "19551": 120, "48172": 120, "93020": 120, "29182": 120, "163593561": 120, "1635935606538312": 120, "96588": 120, "02104": 120, "00611": 120, "00314": 120, "00020": 120, "6614715136": 120, "122863755794": 120, "126903786231": 120, "02833405": 120, "00776828": 120, "127000620590": 120, "0000968344": 120, "00059929": 120, "00019720": 120, "00578585": 120, "127000720853": 120, "0000001003": 120, "00001092": 120, "00000385": 120, "00034224": 120, "127000720883": 120, "00000582": 120, "1270007209": 120, "7884722345": 120, "0000000052": 120, "57494": 120, "18567": 120, "49365": 120, "89695": 120, "28732": 120, "162750763": 120, "1627507630215632": 120, "96266": 120, "02457": [120, 143], "00613": 120, "00017": 120, "00296": 120, "00022": [120, 144], "5879746788": 120, "112220769289": 120, "116294268816": 120, "02764470": 120, "00815308": 120, "116391213357": 120, "0000969445": 120, "00055877": 120, "00018803": 120, "00530657": 120, "116391300399": 120, "0000000870": 120, "00001254": 120, "00000437": 120, "00032420": 120, "116391300440": 120, "00000699": 120, "1163913004": 120, "7043659792": 120, "0000000013": [120, 143], "54852": 120, "16505": 120, "51701": 120, "84044": 120, "28349": 120, "154081706": 120, "1540817061165314": 120, "95470": 120, "03339": 120, "00599": 120, "00025": 120, "00002": 120, "140073481": 120, "1400734808710469": 120, "94416": 120, "04503": 120, "00565": 120, "00027": 120, "4409810091": 120, "057057778249": 120, "061017008512": 120, "02498883": 120, "00837395": 120, "061111945190": 120, "0000949367": 120, "00043469": 120, "00015110": 120, "00450475": 120, "061111997775": 120, "0000000526": 120, "00001623": 120, "00000553": 120, "00026831": 120, "061111997850": 120, "00000968": 120, "0611119978": 120, "5020930069": 120, "0000000004": [120, 143], "48526": 120, "10025": 120, "58296": 120, "72928": 120, "31531": 120, "106855193": 120, "1068551925482586": 120, "91211": 120, "07966": 120, "00030": 120, "3527848073": 120, "999019668155": 120, "002120347046": 120, "02044695": 120, "00718048": 120, "002192720639": 120, "0000723736": 120, "00029841": 120, "00010488": 120, "00418857": 120, "002192745431": 120, "0000000248": 120, "00001282": 120, "00000447": 120, "00019427": 120, "002192745478": 120, "00000804": 120, "0021927455": 120, "3549775527": 120, "43916": 120, "04030": 120, "64366": 120, "67571": 120, "27713": 120, "38302": 120, "061534950": 120, "0615349496254003": 120, "82407": 120, "17146": 120, "00246": 120, "00026": 120, "00065": 120, "2645886055": 120, "920706243669": 120, "921886356635": 120, "01150627": 120, "00406041": 120, "921908589697": 120, "0000222331": 120, "00012300": 120, "00004281": 120, "00260878": 120, "921908594102": 120, "0000000044": 120, "00000367": 120, "00000128": [120, 143], "00008607": 120, "921908594106": 120, "00000249": 120, "9219085941": 120, "1864971996": 120, "38571": 120, "03585": 120, "65320": 120, "67021": 120, "34213": 120, "45332": 120, "017594114": 120, "0175941140438802": 120, "56605": 120, "43300": 120, "00006": 120, "00010": 120, "00004": 120, "2116708844": 120, "864890569654": 120, "865323130286": 120, "00662539": 120, "00233203": 120, "865330119957": 120, "0000069897": 120, "00002402": 120, "00000842": 120, "00153364": 120, "865330120137": 120, "00000130": 120, "00000045": 120, "00001924": 120, "865330120138": 120, "00000098": 120, "8653301201": 120, "0770010045": 120, "34934": 120, "08466": 120, "62463": 120, "66777": 120, "45319": 120, "46317": 120, "003129251": 120, "003129251227058": 120, "30747": 120, "69238": 120, "1763924036": 120, "826215752307": 120, "826444448804": 120, "00461717": 120, "00162670": 120, "826447843878": 120, "0000033951": 120, "00000214": [120, 148], "00000076": [120, 143], "00110952": 120, "826447843880": 120, "00000021": 120, "00000007": [120, 143], "00000161": 120, "8264478439": 120, "0028402475": 120, "0000002057": 120, "32328": 120, "11576": 120, "59484": 120, "67845": 120, "46177": 120, "999550619": 120, "9995506185969377": 120, "15006": 120, "84991": 120, "1511934888": 120, "799871798054": 120, "799991332224": 120, "00320033": 120, "00112755": 120, "799992972433": 120, "0000016402": 120, "00000479": 120, "00000169": 120, "00078939": 120, "799992972441": 120, "00000017": 120, "00000006": [120, 143], "00000407": [120, 143], "7999929724": 120, "9511864613": 120, "0000001692": 120, "30398": 120, "13570": 120, "59106": 120, "67000": 120, "46240": 120, "998771056": 120, "9987710557416043": 120, "07018": 120, "92981": 120, "1322943027": 120, "782139853255": 120, "782197472959": 120, "00214017": 120, "00075393": 120, "782198208427": 120, "0000007355": 120, "00000243": 120, "00000086": [120, 143], "00053449": 120, "782198208429": 120, "00000212": 120, "7821982084": 120, "9144925112": 120, "0000000737": 120, "28967": 120, "14868": 120, "60146": 120, "65436": 120, "46422": 120, "46443": 120, "998606186": 120, "9986061861413569": 120, "03178": 120, "96822": 120, "1175949358": 120, "770215954354": 120, "770245883432": 120, "00149442": 120, "00052645": 120, "770246242419": 120, "0000003590": 120, "00000095": 120, "00000034": 120, "00037504": 120, "7702462424": 120, "8878411782": 120, "0000009489": 120, "27925": 120, "15756": 120, "61352": 120, "64164": 120, "46607": 120, "46635": 120, "998569095": 120, "99856909473122": 120, "01383": 120, "98617": 120, "1058354422": 120, "762026297205": 120, "762044195778": 120, "00112546": 120, "00039650": 120, "762044399480": 120, "0000002037": 120, "00000038": 120, "00000013": [120, 143], "00028293": 120, "7620443995": 120, "8678798417": 120, "0000003765": 120, "27168": 120, "16408": 120, "62166": 120, "63412": 120, "46736": 120, "46760": 120, "998559877": 120, "9985598772014367": 120, "00568": 120, "99432": 120, "length_includes_head": 120, "head_width": 120, "head_length": 120, "edgecolor": 120, "whenev": [120, 157], "truli": 120, "ethen": [120, 131, 133, 142, 143, 153], "923274": 120, "238289": 120, "668188": 120, "eht": 120, "orbitalguess": 120, "guessorb": 120, "cas_orbit": [120, 124, 144], "mcscfdrv": 120, "mcresult": 120, "sv_p_": 120, "737843601": 120, "976388879": 120, "016080942": 120, "019128794": 120, "019331249": 120, "019362607": 120, "019365983": 120, "019366505": 120, "019366536": 120, "019366538": 120, "0193665376418": 120, "98365": 120, "92629": 120, "07350": 120, "01656": 120, "77861": 120, "63704": 120, "50339": 120, "984": 120, "74951": 120, "36398": 120, "074": 120, "26140": 120, "96850": 120, "20754": 120, "23435": 120, "25745": 120, "98365468": 120, "92628668": 120, "07349929": 120, "01655935": 120, "ipython": [120, 133], "ethene_bond_break": 120, "coords_shift": 120, "sigma_max": 120, "argmax": 120, "pi_max": 120, "shorter": 120, "frustrat": 120, "arguabl": [120, 122], "mild": 120, "famou": 120, "chromium": 120, "9p": 120, "427350": 120, "2086": [120, 156], "226771425": 120, "292217657": 120, "303001849": 120, "305479044": 120, "305829379": 120, "305864713": 120, "305869953": 120, "305870598": 120, "305870706": 120, "305870726": 120, "305870730": 120, "305870729": 120, "305870729343": 120, "91210": 120, "81415": 120, "78607": 120, "59980": 120, "40096": 120, "20939": 120, "18598": 120, "09065": 120, "11529": 120, "03811": 120, "912": 120, "20539": 120, "28977": 120, "786": 120, "26152": 120, "2d0": 120, "15528": 120, "401": 120, "12625": 120, "28096": 120, "186": 120, "27552": 120, "07388": 120, "3p0": 120, "10910": 120, "12124": 120, "000051": 120, "91210146": 120, "81415425": 120, "81415422": 120, "78607309": 120, "59979678": 120, "59979666": 120, "40096061": 120, "40096047": 120, "20939453": 120, "18597783": 120, "18597781": 120, "0906523": 120, "uhf": [121, 143, 144, 145, 148], "unpair": 122, "proce": 122, "earth": 122, "au2kcal": 122, "rodft": 122, "triplet_rodft_drv": 122, "triplet_rodft_result": 122, "triplet_udft_drv": 122, "triplet_udft_result": 122, "ow": 122, "rob3lyp": 122, "ub3lyp": 122, "33014560": 122, "33392791": 122, "78650": 122, "52369": 122, "50972": 122, "20092": 122, "23772": 122, "79595": 122, "83473": 122, "56129": 122, "54325": 122, "29937": 122, "21614": 122, "78644": 122, "80682": 122, "89114": 122, "25526": 122, "74211": 122, "50336": 122, "45864": 122, "10410": 122, "26034": 122, "80590": 122, "86451": 122, "006227": 122, "triplet_rohf_drv": 122, "triplet_rohf_result": 122, "triplet_mcscf_drv": 122, "singlet_rdft_drv": 122, "singlet_rdft_result": 122, "79052": 122, "52746": 122, "51773": 122, "50968": 122, "24089": 122, "17013": 122, "23373": 122, "79320": 122, "82293": 122, "84078": 122, "92128398": 122, "29472211": 122, "rsp_drv": [122, 153], "rsp_result": [122, 153], "732361": 122, "18892342": 122, "56236155": 122, "singlet_udft_drv": 122, "singlet_udft_result": 122, "rdft": 122, "27130784": 122, "impetu": 122, "stuck": 122, "a_occ": 122, "b_occ": 122, "broken_udft_drv": 122, "broken_udft_result": 122, "01237": 122, "80124": 122, "51076": 122, "20217": 122, "91738": 122, "65807": 122, "34841": 122, "308167": 122, "003282": 122, "61633376": 122, "wab": 122, "singlet_mcscf_drv": 122, "69991698": 122, "spin_restrict": 122, "all_mcscf_drv": 122, "55599147": 122, "11198294": 122, "ly": [122, 141, 143, 144, 149], "great": 122, "large_mcscf_drv": 122, "00271262": 122, "02178824": 122, "707": 122, "jablonski": 123, "timescal": 123, "intersystem": 123, "phosphoresc": 123, "ultrafast": 123, "femtosecond": 123, "onto": [123, 144], "vibration": 123, "gound": 123, "vibrationali": 123, "inten": 123, "gridspec": [124, 144], "gaseou": 124, "rpa_solv": [124, 151, 153], "lreigensolv": [124, 151, 153], "rpa_result": [124, 144, 151, 153], "286": [124, 136, 151], "24321": [124, 151], "364": [124, 151], "09652": [124, 151], "63080": [124, 151], "454": [124, 151, 156], "08684": [124, 151], "53570": [124, 151], "540": [124, 144, 148, 151], "41655": [124, 151], "07524": [124, 151], "24377": [124, 151], "74073": [124, 151], "freqs_str": [124, 142, 144], "rsplinabscross": [124, 144], "linearabsorptioncrosssect": [124, 142, 144], "init_driv": [124, 142, 144], "cpp_result": [124, 144], "axx": [124, 142, 144], "rsp_properti": [124, 142, 144], "ayi": [124, 142, 144], "azz": [124, 142, 144], "alpha_bar": [124, 142, 144], "035999": [124, 142, 144], "raw": [124, 144], "width_ratio": [124, 144], "bx": [124, 144], "get_molecul": [124, 125, 142, 144, 145, 153], "get_molecular_basi": [124, 125, 142, 144, 145, 153], "scf_g": [124, 125, 136, 142, 143, 144, 145, 148, 153], "adc_result": [124, 144, 153], "adc3": [124, 143], "resul": 124, "convolut": [124, 144, 145, 151], "adc2": [124, 125, 143, 144, 145, 148, 153], "plot_spectrum": [124, 125, 143, 144, 145, 148], "xaxi": 124, "222": [124, 143, 144], "nm": [124, 130, 131, 132, 150, 156], "224": [124, 143], "v2": [124, 125, 144, 145, 153], "3127134": 124, "509364": 124, "0134": [124, 156], "951": 124, "04895": 124, "3933877": 124, "70463": 124, "9532": 124, "04681": 124, "4056694": 124, "03883": 124, "1161": [124, 156], "9491": 124, "05091": 124, "4916579": 124, "37869": 124, "949": [124, 156], "05096": 124, "5655096": 124, "3883": 124, "4351": 124, "9625": 124, "03751": 124, "6977152": 124, "9858": 124, "2604": 124, "9537": 124, "04626": 124, "discret": [124, 144], "flatten": [124, 144], "suspect": 124, "conic": 124, "someth": [124, 148], "tradit": 124, "compris": 124, "617648941": 124, "642903350": 124, "646125925": 124, "646212175": 124, "646218727": 124, "646219045": 124, "646219063": 124, "646219065": 124, "98281062496625": 124, "98486": 124, "99960": 124, "00851": 124, "70404926196608": 124, "98828": 124, "99728": 124, "99912": 124, "01531": 124, "62045138647316": 124, "99530": 124, "99422": 124, "01264": 124, "99784": 124, "60225041976662": 124, "96141": 124, "99969": 124, "22263": 124, "77478": 124, "04148": 124, "52004110975072": 124, "97752": 124, "01676": 124, "02746": 124, "97865": 124, "44771158728813": 124, "01935": 124, "99895": 124, "97990": 124, "02395": 124, "68879": 124, "45143": 124, "816": 124, "76930": 124, "52443": 124, "59973": 124, "501": 124, "10225": 124, "351": 124, "21690": 124, "99875": 124, "06993": 124, "848594": 124, "156911": 124, "088075": 124, "223865": 124, "019117": 124, "048591": 124, "127030": 124, "322878": 124, "138716": 124, "352582": 124, "255728": 124, "649995": 124, "58548": 124, "220177e": 124, "799370e": 124, "35557": 124, "097829e": 124, "281789e": 124, "59260": 124, "545515e": 124, "469851e": 124, "56079": 124, "993553e": 124, "307390e": 124, "01220": 124, "381": [124, 156], "10978": 124, "463": 124, "15455": 124, "535": [124, 144], "59936": 124, "rspdict": [124, 144], "991165249": 124, "005855741": 124, "031621117": 124, "034371736": 124, "036920247": 124, "037128966": 124, "037231330": 124, "037270318": 124, "037273265": 124, "037273978": 124, "037274020": 124, "03727403227734": 124, "55476": 124, "07550": 124, "83333": 124, "70219": 124, "75293": 124, "73231": 124, "67761": 124, "78417": 124, "983137": 124, "498886": 124, "711592304": 124, "532277685": 124, "472274167": 124, "455154316": 124, "453380481": 124, "452031444": 124, "451970822": 124, "451896428": 124, "451894976": 124, "451891023": 124, "451890969": 124, "451890957": 124, "3305189": 124, "99388": 124, "0389564": 124, "4084659": 124, "11492": 124, "4307432": 124, "72112": 124, "1738586": 124, "1284586": 124, "5110794": 124, "90718": 124, "1450281": 124, "1453586": 124, "5786474": 124, "74580": 124, "3465044": 124, "4062187": 124, "set_figheight": 124, "set_figwidth": 124, "silent_ostream": [125, 145], "mpi4pi": [125, 145], "comm_world": [125, 145], "ch3oh_mol_str": 125, "6627602692": 125, "0195253241": 125, "7482324502": 125, "1217146925": 125, "0282229693": 125, "5397922417": 125, "8872632580": 125, "0781531801": 125, "9835591659": 125, "1253011321": 125, "7605402778": 125, "struct": [125, 142, 144, 145], "adc_r": [125, 145], "3876414915": 125, "986646483208": 125, "986647455185": 125, "00019765": 125, "00003189": 125, "986647466155": 125, "0000000110": 125, "00008804": 125, "00001229": 125, "00014964": 125, "986647467682": 125, "0000000015": 125, "00001316": 125, "00000245": 125, "00005028": 125, "986647467711": 125, "00000768": 125, "00000123": 125, "00000788": 125, "986647467718": 125, "00000092": 125, "00000020": 125, "00000271": 125, "9866474677": 125, "3742889592": 125, "0000009201": 125, "68674": 125, "62359": 125, "58786": 125, "49474": 125, "44686": 125, "21888": 125, "27257": 125, "31271": 125, "32064": 125, "37611": 125, "23909": 125, "228m": 125, "40241316": 125, "48084642": 125, "51034518": 125, "52072285": 125, "55248738": 125, "55772689": 125, "010561": 125, "456m": 125, "29557131": 125, "37845885": 125, "39618815": 125, "4170348": 125, "44699784": 125, "45009195": 125, "0038423": 125, "670m": 125, "29423544": 125, "37469582": 125, "38629969": 125, "41095523": 125, "43604013": 125, "43686795": 125, "00035144": 125, "839m": 125, "29417706": 125, "37426126": 125, "38422222": 125, "40954519": 125, "43305633": 125, "43490802": 125, "7396e": 125, "29417387": 125, "37422958": 125, "38413954": 125, "40949836": 125, "43288848": 125, "43484835": 125, "5709e": 125, "898m": 125, "29417373": 125, "37422705": 125, "3841368": 125, "40949611": 125, "4328759": 125, "43484511": 125, "3958e": 125, "713m": 125, "29417371": 125, "37422666": 125, "38413652": 125, "40949598": 125, "43287347": 125, "43484478": 125, "886m": 125, "2941737": 125, "004874": 125, "9527": 125, "04731": 125, "3742267": 125, "18323": 125, "0109": [125, 153, 156], "9533": 125, "04671": 125, "3841365": 125, "45289": 125, "0868": [125, 156], "9329": 125, "06713": 125, "409496": 125, "14295": 125, "9455": 125, "05445": 125, "4328735": 125, "77909": 125, "1071": [125, 156], "9252": 125, "07478": 125, "4348448": 125, "83273": 125, "0266": [125, 156], "9439": 125, "05607": 125, "describe_amplitud": [125, 142, 153], "652": 125, "0575": [125, 156], "0233": [125, 156], "0232": [125, 156], "0206": [125, 156], "0196": [125, 156], "0175": [125, 156], "0165": [125, 156], "0105": [125, 156], "0157": [125, 156], "012": 125, "0117": [125, 153, 156], "0116": [125, 156], "0798": [125, 156], "0596": [125, 156], "0456": [125, 156], "0436": [125, 156], "0369": [125, 156], "0291": [125, 156], "0278": [125, 156], "0198": [125, 156], "015": 125, "0133": [125, 153, 156], "0126": [125, 156], "0187": [125, 156], "0146": [125, 156], "0118": [125, 156], "0102": [125, 156], "0918": [125, 156], "0871": [125, 156], "0437": [125, 156], "0258": [125, 156], "0192": [125, 156], "0167": [125, 156], "0199": [125, 156], "0179": [125, 156], "0149": [125, 156], "0122": [125, 156], "0113": [125, 156], "0111": [125, 156], "529": 125, "389": 125, "0715": [125, 156], "0705": [125, 156], "0628": [125, 156], "0623": [125, 156], "0354": [125, 156], "0261": [125, 156], "0239": [125, 156], "0151": [125, 156], "0148": [125, 156], "0138": [125, 156], "013": [125, 153], "0106": [125, 156], "0101": [125, 156], "119": [125, 156], "0857": [125, 156], "0766": [125, 156], "0627": [125, 156], "0411": [125, 156], "027": 125, "0202": [125, 156], "0147": [125, 153, 156], "0144": [125, 153, 156], "0115": [125, 153, 156], "0346": [125, 156], "0197": [125, 156], "0194": [125, 156], "0178": [125, 144, 145, 156], "0143": [125, 153, 156], "0132": [125, 156], "0119": [125, 156], "0104": [125, 153, 156], "0103": [125, 156], "404": 125, "0685": [125, 156], "0624": [125, 156], "0513": [125, 156], "0464": [125, 156], "0256": [125, 156], "0242": [125, 156], "0203": [125, 156], "0164": [125, 156], "0135": [125, 156], "0129": [125, 156], "0125": [125, 156], "0112": [125, 156], "narrow": 125, "strongest": 125, "toler": [125, 142], "split_r": 125, "sim0": 125, "transition_dipole_mo": [125, 142], "10570323e": 125, "50586668e": 125, "82241208e": 125, "17627387e": 125, "21072518e": 125, "16603011e": 125, "favorit": 126, "agre": 126, "disagre": 126, "protocol": [126, 148], "expert": [128, 149], "incomplet": [128, 149], "unavoid": [128, 149], "bias": [128, 149], "cc2": [128, 149], "tendenc": [128, 143], "cpp": [128, 142, 143, 149], "heavili": [128, 143, 148], "advis": [128, 133, 143], "might": [128, 133, 143, 144], "safest": [128, 149], "dun": [128, 143, 149], "rydberg": [128, 144, 149, 150], "elast": 129, "stoke": 129, "ultraviolet": 129, "tune": [129, 141, 143], "yellow": [129, 159], "promot": 130, "coval": 130, "epsilon_0c": 130, "k0": 130, "fingerprint": 130, "identif": 130, "950": 130, "896": 130, "317": 130, "hessian_drv": 130, "print_hessian": 130, "hood": 130, "vibrational_analysi": [130, 131, 132, 156], "list_ex_energi": [130, 131, 132, 156], "list_osci_strength": [130, 131, 132, 156], "line_param": [130, 131, 132, 156], "amin": [130, 131, 132, 156], "amax": [130, 131, 132, 156], "xp": [130, 131, 132, 141, 143, 144, 149, 156], "ir_intens": [130, 131, 156], "x1i": [130, 142], "y1i": [130, 142], "sepctrum": [130, 156], "symmetryc": 130, "bend": 130, "get_normal_mod": [130, 131, 132, 156], "normal_mod": [130, 131, 132, 156], "natm": [130, 131, 132, 153, 156], "vib_xyz": [130, 131, 132, 156], "vib_1": 130, "vib_2": 130, "vib_3": 130, "1927": 130, "4545": [130, 156], "4896": 130, "663984": 131, "919796": 131, "223061": 131, "ethene_basi": 131, "fluoroethene_xyz": 131, "fluoroethen": 131, "519796": 131, "fluoroethene_basi": 131, "chloroethene_xyz": 131, "chloroethen": 131, "chloroethene_basi": 131, "ethene_scf_drv": 131, "fluoroethene_scf_drv": 131, "chloroethene_scf_drv": 131, "ethene_scf_result": 131, "fluoroethene_scf_result": 131, "chloroethene_scf_result": 131, "ethene_grad_drv": 131, "fluoroethene_grad_drv": 131, "chloroethene_grad_drv": 131, "ethene_opt_drv": 131, "fluoroethene_opt_drv": 131, "chloroethene_opt_drv": 131, "opt_ethen": 131, "opt_fluoroethen": 131, "opt_chloroethen": 131, "uncom": [131, 156], "unmut": 131, "ir_raman": [131, 132], "get_xyz": 131, "hessian_set": [131, 132], "do_raman": [131, 132], "print_depolarization_ratio": [131, 132], "ethene_hessian_drv": 131, "fluoroethene_hessian_drv": 131, "chloroethene_hessian_drv": 131, "h5py": [131, 132, 156], "fname": [131, 132, 156], "h5": [131, 132, 143, 156], "_hessian": [131, 132], "dipole_gradi": [131, 132, 156], "_dipolegrad": [131, 132], "polarizability_gradi": [131, 132], "_polgrad": [131, 132], "eth_x": 131, "eth_ir": 131, "flo_x": 131, "flo_ir": 131, "chl_x": 131, "chl_ir": 131, "eth_xl": 131, "eth_irl": 131, "flo_xl": 131, "flo_irl": 131, "chl_xl": 131, "chl_irl": 131, "3200": [131, 156], "3500": [131, 156], "sepctra": [131, 132], "eth_raman": 131, "raman_intens": [131, 132], "flo_raman": 131, "chl_raman": 131, "eth_ramanl": 131, "flo_ramanl": 131, "chl_ramanl": 131, "amu": [131, 132, 156], "ethene_h1": 131, "fluoroethene_h1": 131, "chloroethene_h1": 131, "ration": 131, "ethene_prop": 131, "compute_scf_prop": 131, "ethene_dipole_mo": 131, "fluoroethene_prop": 131, "fluoroethene_dipole_mo": 131, "chloroethene_prop": 131, "chloroethene_dipole_mo": 131, "ethene_mo": 131, "fluoroethene_mo": 131, "new_ethene_scf_drv": 131, "ethene_displac": 131, "ethene_label": 131, "new_fluoroethene_scf_drv": 131, "fluoroethene_displac": 131, "fluoroethene_label": 131, "x_list": 131, "ethene_coord": 131, "new_ethen": 131, "new_ethene_scf_result": 131, "fluoro_coord": 131, "new_fluoroethen": 131, "new_fluoroethene_scf_result": 131, "ethene_moments_arrai": 131, "fluoroethene_moments_arrai": 131, "plt1": 131, "plt2": 131, "ethene_lrdrv": 131, "lrsolver": 131, "ethene_pol_dict": 131, "ethene_polariz": 131, "fluoroethene_lrdrv": 131, "fluoroethene_pol_dict": 131, "fluoroethene_polariz": 131, "chloroethene_lrdrv": 131, "chloroethene_pol_dict": 131, "chloroethene_polariz": 131, "ethene_pol": 131, "fluoroethene_pol": 131, "new_ethene_lrdrv": 131, "new_fluoroethene_lrdrv": 131, "new_ethene_pol_dict": 131, "new_fluoroethene_pol_dict": 131, "ethene_polarizability_arrai": 131, "fluoroethene_polarizability_arrai": 131, "inelas": 132, "nh": [132, 143], "ch": [132, 133, 136, 139, 142, 143, 144], "opt_h2o": 132, "nh3_xyz": 132, "opt_nh3": 132, "ch4_xyz": 132, "opt_ch4": 132, "h2o_basi": 132, "nh3": 132, "nh3_basi": 132, "ch4": 132, "ch4_basi": 132, "h2o_scf_drv": 132, "h2o_result": [132, 136], "nh3_scf_drv": 132, "nh3_result": 132, "ch4_scf_drv": 132, "ch4_result": [132, 136], "h2o_hessian_drv": 132, "nh3_hessian_drv": 132, "ch4_hessian_drv": 132, "h2o_x": 132, "h2o_i": 132, "nh3_x": 132, "nh3_y": 132, "ch4_x": 132, "ch4_y": 132, "h2o_xl": 132, "h2o_yl": 132, "nh3_xl": 132, "nh3_yl": 132, "ch4_xl": 132, "ch4_yl": 132, "h2o_h1": 132, "h2o_h2": 132, "nh3_h1": 132, "nh3_h2": 132, "nh3_h3": 132, "ch4_h1": 132, "ch4_h2": 132, "ch4_h3": 132, "ch4_h4": 132, "entri": 133, "bank": 133, "babel": [133, 139], "caffein": 133, "smiles_str": 133, "cn1c": 133, "nc2": 133, "c1c": 133, "n2c": 133, "caffeine_molecul": 133, "mmff94": [133, 139], "caffeine_xyz": 133, "246030000000": 133, "130310000000": 133, "025980000000": 133, "262080000000": 133, "077920000000": 133, "007760000000": 133, "516750000000": 133, "268080000000": 133, "001470000000": 133, "402970000000": 133, "973590000000": 133, "005650000000": 133, "410650000000": 133, "040380000000": 133, "000280000000": 133, "905090000000": 133, "228440000000": 133, "004840000000": 133, "080570000000": 133, "385890000000": 133, "010540000000": 133, "536520000000": 133, "525370000000": 133, "015680000000": 133, "283180000000": 133, "078550000000": 133, "010220000000": 133, "833810000000": 133, "220410000000": 133, "006860000000": 133, "056760000000": 133, "390670000000": 133, "007920000000": 133, "939960000000": 133, "291810000000": 133, "003250000000": 133, "425170000000": 133, "659750000000": 133, "004880000000": 133, "230720000000": 133, "175770000000": 133, "018140000000": 133, "247690000000": 133, "693450000000": 133, "002350000000": 133, "117910000000": 133, "709050000000": 133, "944170000000": 133, "099090000000": 133, "761210000000": 133, "854070000000": 133, "519330000000": 133, "677350000000": 133, "002970000000": 133, "517080000000": 133, "705220000000": 133, "028990000000": 133, "035370000000": 133, "176560000000": 133, "887670000000": 133, "073880000000": 133, "164310000000": 133, "900710000000": 133, "742510000000": 133, "153400000000": 133, "018220000000": 133, "861160000000": 133, "094140000000": 133, "909710000000": 133, "871610000000": 133, "099260000000": 133, "866370000000": 133, "smiles_to_xyz": [133, 136], "svg": 133, "draw_2d": 133, "sequenti": [133, 140], "alkan": [133, 136], "methane_xyz": 133, "ethane_xyz": 133, "propane_xyz": 133, "ccc": 133, "butane_xyz": 133, "cccc": 133, "ethyn": 133, "ethyne_xyz": 133, "paranthesi": 133, "nest": 133, "hexan": 133, "ethylheptan": 133, "hexane_xyz": 133, "cccccc": 133, "ethylheptane_xyz": 133, "ccccc": 133, "difluoroethen": [133, 142, 146], "difluoro11_xyz": 133, "difluoro12_xyz": 133, "ethanol": 133, "stagger": [133, 139], "ethanol_initial_xyz": 133, "ethanol_xyz": 133, "cyclohexan": 133, "norbornan": 133, "cyclohexane_xyz": 133, "c1ccccc1": 133, "norborane_xyz": 133, "c1c2ccc": 133, "c1": [133, 143], "aromat": 133, "cymen": 133, "pcymene1_xyz": 133, "pcymene2_xyz": 133, "c1ccc": 133, "cc1": 133, "chemspid": 133, "digit": [133, 142], "nadh": 133, "nad": 133, "nicotinamid": 133, "adenin": 133, "dinucleotid": 133, "partak": 133, "metabol": 133, "redox": 133, "longleftrightarrow": 133, "nadh_xyz": 133, "c1cc": 133, "2o": 133, "cop": 133, "op": 133, "5o": 133, "n4cnc3c": 133, "ncnc34": 133, "nadp_xyz": 133, "urllib": 133, "urlopen": 133, "1aoi": 133, "rcsb": 133, "decod": 133, "utf": 133, "setbackgroundcolor": 133, "methan": 134, "combust": 134, "warm": 134, "gwp": 134, "gase": [134, 141], "reactant": 136, "paper": [136, 153], "compet": 136, "extrapol": 136, "ch4_ff": 136, "h2o_ff": 136, "co2_ff": 136, "o2_ff": 136, "xtb_optim": 136, "xyz_ff": 136, "xtb_drv": [136, 139, 156], "xtb_opt_drv": [136, 139], "xtb_opt": 136, "ch4_xtb": 136, "h2o_xtb": 136, "co2_xtb": 136, "o2_xtb": 136, "mind": [136, 140, 143, 150], "scf_calcul": 136, "molecule_xyz": 136, "ch4_scf": 136, "o2_result": 136, "o2_scf": 136, "co2_result": 136, "co2_scf": 136, "h2o_scf": 136, "e_react": 136, "e_product": 136, "hydrocarbon": 136, "143": 136, "propan": 136, "138": [136, 156], "butan": 136, "544": [136, 144], "heptan": 136, "134": [136, 156], "362051846542": 137, "008519935441": 137, "024906559609": 137, "933468973663": 137, "509856441784": 137, "193822841148": 137, "483698601596": 137, "368885697455": 137, "046180408743": 137, "612499226929": 137, "790059463155": 137, "682044832355": 137, "045997965440": 137, "841433017766": 137, "127103979461": 137, "570778666846": 137, "200864234382": 137, "068115315388": 137, "scf_hf": 137, "hf_result": 137, "01894": 137, "isovalu": 137, "scf_b3lyp": 137, "b3lyp_result": 137, "71437": 137, "methanol_ff": 139, "xtb_opt_result": 139, "methanol_xtb": 139, "methanol_hf": 139, "dm_ff": 139, "get_distance_matrix_in_angstrom": 139, "dm_xtb": 139, "dm_hf": 139, "nan": 139, "dm_tmp": 139, "1e10": 139, "physicochem": 140, "sectroscopi": 141, "photoemiss": 141, "photoion": 141, "xe": [141, 143, 144, 146, 149], "decai": [141, 144, 146, 148], "rix": [141, 143, 144, 145, 149], "abil": [141, 144], "nobl": 141, "nist": 141, "siegbahn": 141, "shield": [141, 143, 144, 150], "necessit": [141, 147], "tailor": [141, 142, 147], "continumm": 141, "exot": [141, 148], "cheat": 141, "sheet": 141, "vinylfluorid": [142, 143], "emphasi": 142, "thereof": 142, "date": 142, "vinylflurid": 142, "fluorin": [142, 143, 144], "electroneg": [142, 144], "deliber": 142, "vinyl_mol_str": [142, 143], "246412": [142, 143], "271068": [142, 143], "457081": [142, 143], "154735": [142, 143], "119195": [142, 143], "052878": [142, 143], "272328": [142, 143], "210194": [142, 143], "319906": [142, 143], "249847": [142, 143], "530323": [142, 143], "095954": [142, 143], "adc_xa": [142, 144, 148], "adc2x": [142, 143, 144, 145], "core_orbit": [142, 143, 144, 145, 148], "mismatch": 142, "conda": 142, "272": 142, "cpp_prop": 142, "284": 142, "280": 142, "296": 142, "index_format": 142, "des_amp": 142, "split_lin": 142, "tmp_amp": 142, "hf_exc1": 142, "hf_exc2": 142, "nfirst": 142, "adcc_exc1": 142, "homolumo": 142, "hoco": 142, "homo_exc1": 142, "63675": 142, "601": [142, 144], "4407": 142, "adc_chf": 142, "adc_ch2": 142, "chf": 142, "x2i": 142, "y2i": 142, "philosophi": [142, 149], "number_mo": 142, "solution_vec": 142, "x_solut": 142, "y_solut": 142, "z_solut": 142, "sx": 142, "sy": 142, "sz": 142, "spec_comp": 142, "x_tmp": [142, 144], "y_tmp": [142, 144], "z_tmp": [142, 144], "comp_x": 142, "comp_i": 142, "comp_z": 142, "cont_chf": 142, "cont_ch2": 142, "cont_ful": 142, "ychf": 142, "ych2": 142, "yfull": 142, "yrest": 142, "monolay": 142, "adc_freq": 142, "skip": [142, 144, 156], "prefactor": 142, "adc_sx": 142, "adc_si": 142, "adc_sz": 142, "tmp_tm": 142, "pertient": 143, "koopman": [143, 146], "water_fluorine_xyz": 143, "gs_result": 143, "scf_ion": [143, 144, 145, 148], "ion_result": 143, "molecule_f": 143, "basis_f": 143, "scf_f": 143, "f_result": 143, "get_rho": 143, "mo1": 143, "mo2": 143, "mo3": 143, "rho3": 143, "az": 143, "mo1_g": 143, "mo1_ion": 143, "mo1_z1": 143, "1a_1": 143, "mo2_g": 143, "mo2_ion": 143, "mo2_z1": 143, "2a_1": 143, "mo2b_g": 143, "mo2b_ion": 143, "mo2b_z1": 143, "alpha_2": [143, 144], "alpha_1": [143, 144], "beta_2": 143, "decontract": [143, 149], "newli": 143, "balanc": [143, 144, 149], "methane_mol_str": 143, "6265918120": 143, "ammonia_mol_str": 143, "1175868000": 143, "9323800000": 143, "2743692000": 143, "4661900000": 143, "8074647660": 143, "hydrofluoride_mol_str": 143, "8261856000": 143, "0917984000": 143, "neon_mol_str": 143, "koopman_vs_delta": 143, "basis_label": [143, 153], "err_koopman": 143, "err_delta": 143, "expt": 143, "e_koopman": 143, "e_delta": 143, "405": [143, 144], "539": [143, 144], "694": 143, "870": 143, "5p": 143, "4937111288": 143, "176641252708": 143, "198632549790": 143, "07238664": 143, "00936881": 143, "199216137990": 143, "0005835882": 143, "00782091": 143, "00076076": 143, "02494254": 143, "199223311012": 143, "0000071730": 143, "00284629": 143, "00029267": 143, "00277747": 143, "199224544997": 143, "0000012340": 143, "00033787": 143, "00004920": 143, "00101091": 143, "199224580340": 143, "0000000353": 143, "00002279": 143, "00032567": 143, "199224580473": 143, "00000241": 143, "00000058": 143, "00002005": 143, "199224580475": 143, "00000024": 143, "1992245805": 143, "6929357092": 143, "0000002419": 143, "21468": 143, "94394": 143, "54399": 143, "19200": 143, "27467": 143, "58864": 143, "vlx_20240321_fe4b088f": 143, "984548233126": 143, "72929056": 143, "75211056": 143, "383245222949": 143, "3986969898": 143, "03746343": 143, "14598216": 143, "84846701": 143, "480740305899": 143, "0974950829": 143, "17120996": 143, "02756281": 143, "34603159": 143, "484157355961": 143, "0034170501": 143, "03303526": 143, "00415502": 143, "06446845": 143, "484720018471": 143, "0005626625": 143, "01405409": 143, "00136720": 143, "02807396": 143, "484843881109": 143, "0001238626": 143, "00254185": 143, "00035196": 143, "01842700": 143, "484845836451": 143, "0000019553": 143, "00046743": 143, "00007033": 143, "00338992": 143, "484845893262": 143, "0000000568": 143, "00008456": 143, "00000995": 143, "00035811": 143, "484845895285": 143, "0000000020": 143, "00001190": 143, "00000137": 143, "00007186": 143, "484845895330": 143, "00000170": 143, "00000025": 143, "00001234": 143, "00000111": 143, "4848458953": 143, "9785570241": 143, "0000001275": 143, "7756": 143, "84796": 143, "45098": 143, "99657": 143, "09031": 143, "02311": 143, "27795": 143, "36903": 143, "96052": 143, "19964": 143, "07555": 143, "01250": 143, "9703270415": 143, "154702188708": 143, "195358785586": 143, "09236701": 143, "01092262": 143, "196206735531": 143, "0008479499": 143, "01551902": 143, "00289180": 143, "03204290": 143, "196232682551": 143, "0000259470": 143, "00329250": 143, "00061368": 143, "00416037": 143, "196236230580": 143, "0000035480": 143, "00129802": 143, "00014764": 143, "00241244": 143, "196236654350": 143, "0000004238": 143, "00047049": 143, "00009292": 143, "00079374": 143, "196236728370": 143, "0000000740": 143, "00006997": 143, "00001054": 143, "00047731": 143, "196236729650": 143, "00000421": 143, "00000053": 143, "00006073": 143, "196236729653": 143, "00000048": 143, "00000255": 143, "1962367297": 143, "1665637711": 143, "0000004806": 143, "53583": 143, "13384": 143, "61616": 143, "42176": 143, "18607": 143, "27050": 143, "72999": 143, "vlx_20240321_699b5ee5": 143, "660410101572": 143, "36296681": 143, "93787381": 143, "122191658113": 143, "4617815565": 143, "36758506": 143, "19392095": 143, "86529171": 143, "266669310780": 143, "1444776527": 143, "21528914": 143, "02793667": 143, "35551128": 143, "271020414677": 143, "0043511039": 143, "03449561": 143, "00531354": 143, "06580037": 143, "271483608593": 143, "0004631939": 143, "01412355": 143, "00223336": 143, "02171266": 143, "271579300234": 143, "0000956916": 143, "00321463": 143, "00044586": 143, "01358060": 143, "271582780015": 143, "0000034798": 143, "00076046": 143, "00010369": 143, "00252762": 143, "271582946469": 143, "0000001665": 143, "00015419": 143, "00002015": 143, "00053815": 143, "271582952575": 143, "0000000061": 143, "00003472": 143, "00000430": 143, "00011550": 143, "271582952900": 143, "00000726": 143, "00000138": 143, "00002156": 143, "271582952917": 143, "00000201": 143, "00000041": 143, "00000518": 143, "271582952918": 143, "00000036": 143, "2715829529": 143, "2419099944": 143, "0000003577": 143, "7708": 143, "57272": 143, "71997": 143, "14527": 143, "13072": 143, "05496": 143, "38300": 143, "62136": 143, "09628": 143, "93070": 143, "30674": 143, "11641": 143, "04172": 143, "37116": 143, "980954854746": 143, "025912394461": 143, "10613691": 143, "01096404": 143, "026931952439": 143, "0010195580": 143, "02019241": 143, "00280757": 143, "02550308": 143, "026976262238": 143, "0000443098": 143, "00419173": 143, "00085956": 143, "00453733": 143, "026979226222": 143, "0000029640": 143, "00218984": 143, "00030105": 143, "00163383": 143, "026979655187": 143, "0000004290": 143, "00033786": 143, "00007031": 143, "00046129": 143, "026979678134": 143, "0000000229": 143, "00003955": 143, "00000573": 143, "00016589": 143, "026979678489": 143, "00000246": 143, "00002137": 143, "026979678490": 143, "00000049": 143, "0269796785": 143, "1831243979": 143, "0000004877": 143, "55028": 143, "33471": 143, "69724": 143, "56644": 143, "49324": 143, "18437": 143, "25556": 143, "78577": 143, "84995": 143, "16230": 143, "vlx_20240321_1c9dbfed": 143, "476698768014": 143, "00725477": 143, "00603661": 143, "031465126004": 143, "5547663580": 143, "49516221": 143, "19142953": 143, "85523582": 143, "177378495754": 143, "1459133698": 143, "20617595": 143, "03128268": 143, "33481131": 143, "180651358574": 143, "0032728628": 143, "03175806": 143, "00523624": 143, "05436888": 143, "180957941862": 143, "0003065833": 143, "01110568": 143, "00195632": 143, "01691272": 143, "181002534103": 143, "0000445922": 143, "00267353": 143, "00047453": 143, "00810046": 143, "181004700115": 143, "0000021660": 143, "00061110": 143, "00007448": 143, "00172878": 143, "181004792916": 143, "0000000928": 143, "00009944": 143, "00001508": 143, "00036532": 143, "181004794731": 143, "0000000018": 143, "00001782": 143, "00000370": 143, "00005401": 143, "181004794796": 143, "00000300": 143, "00000068": 143, "00000901": 143, "181004794798": 143, "00000011": 143, "00000154": 143, "1810047948": 143, "3371495142": 143, "0000007610": 143, "7648": 143, "02738": 143, "32957": 143, "23386": 143, "18294": 143, "17239": 143, "10078": 143, "37249": 143, "39727": 143, "59798": 143, "90790": 143, "26787": 143, "15789": 143, "10427": 143, "14601": 143, "15857": 143, "08775": 143, "36931": 143, "40896": 143, "1881022960": 143, "988874777753": 143, "018768000115": 143, "09773637": 143, "01303368": 143, "019585862254": 143, "0008178621": 143, "02190606": 143, "00305029": 143, "02171836": 143, "019640824607": 143, "0000549624": 143, "00566262": 143, "00116714": 143, "00487750": 143, "019645492095": 143, "0000046675": 143, "00331753": 143, "00040416": 143, "00201343": 143, "019646381262": 143, "0000008892": 143, "00037277": 143, "00005411": 143, "00064692": 143, "019646410026": 143, "0000000288": 143, "00003872": 143, "00000711": 143, "00017580": 143, "019646410326": 143, "00000210": 143, "00001858": 143, "019646410327": 143, "00000019": 143, "00000071": 143, "0196464103": 143, "2077487064": 143, "0000001942": 143, "27716": 143, "58313": 143, "74719": 143, "62915": 143, "18337": 143, "80873": 143, "40908": 143, "41388": 143, "vlx_20240321_e659e5d5": 143, "742490771103": 143, "65394692": 143, "19371628": 143, "398937627258": 143, "6564468562": 143, "45174136": 143, "15266049": 143, "80606973": 143, "507809858140": 143, "1088722309": 143, "15003366": 143, "02152883": 143, "27290087": 143, "509195127826": 143, "0013852697": 143, "02481321": 143, "00345443": 143, "03446813": 143, "509328657671": 143, "0001335298": 143, "00650857": 143, "00110570": 143, "01088816": 143, "509339136024": 143, "0000104784": 143, "00159980": 143, "00028573": 143, "00336728": 143, "509339787444": 143, "0000006514": 143, "00032453": 143, "00004058": 143, "00089691": 143, "509339810128": 143, "0000000227": 143, "00004148": 143, "00000612": 143, "00018196": 143, "509339810308": 143, "00000481": 143, "00001225": 143, "509339810311": 143, "00000052": 143, "00000206": 143, "5093398103": 143, "6974421063": 143, "0000005166": 143, "7589": 143, "25722": 143, "41524": 143, "54540": 143, "46185": 143, "21792": 143, "30737": 143, "73464": 143, "84884": 143, "28147": 143, "46527": 143, "37679": 143, "76185": 143, "20513": 143, "31497": 143, "77758": 143, "488925926667": 143, "488925929027": 143, "00008363": 143, "00002132": 143, "488925929352": 143, "00001743": 143, "00000273": 143, "00001389": 143, "488925929371": 143, "00000043": 143, "00000014": [143, 148], "00000294": 143, "4889259294": 143, "0000004282": 143, "76419": 143, "91886": 143, "83240": 143, "69054": 143, "09313": 143, "19630": 143, "vlx_20240321_16a2e6a2": 143, "724739415048": 143, "28148132": 143, "26602289": 143, "447251770784": 143, "7225123557": 143, "28775994": 143, "20942739": 143, "73277939": 143, "508840201458": 143, "0615884307": 143, "08798008": 143, "01988639": 143, "19104619": 143, "509196421834": 143, "0003562204": 143, "01626179": 143, "00327620": 143, "01701992": 143, "509231483788": 143, "0000350620": 143, "00285999": 143, "00052555": 143, "00566536": 143, "509232485076": 143, "0000010013": 143, "00010250": 143, "00003847": 143, "00110714": 143, "509232486360": 143, "00001338": 143, "00000395": 143, "00004150": 143, "509232486370": 143, "00000063": 143, "00000278": 143, "5092324864": 143, "0000006335": 143, "7549": 143, "33903": 143, "94250": 143, "86722": 143, "89666": 143, "25223": 143, "43099": 143, "79165": 143, "77472": 143, "22975": 143, "94282": 143, "35039": 143, "ro": 143, "zorder": 143, "wrt": 143, "mole": [143, 144, 145, 148], "unc": 143, "xas_adc1": 143, "cvs_adc1": 143, "n_singlet": [143, 144], "xas_adc2": 143, "cvs_adc2": [143, 144, 148], "xas_adc2x": 143, "cvs_adc2x": 143, "xas_adc3": 143, "cvs_adc3": 143, "mo0": [143, 144, 145, 148], "occ0": [143, 144, 145, 148], "alpha_0": [143, 145], "addon": [143, 144, 145, 148], "mom_occ": [143, 144, 145, 148], "xes_adc1": 143, "xes_adc2": 143, "xes_adc2x": 143, "xes_adc3": 143, "534": [143, 148], "bo": 143, "527": [143, 156], "influenti": [143, 144], "greatli": 143, "l_1": 143, "pv": 143, "pcv": 143, "u6": [143, 149], "un6": 143, "toggl": 143, "u6311gss": 143, "pars": 143, "8588": 143, "1297": [143, 156], "230": 143, "2960": [143, 156], "37710": 143, "67890": 143, "740040": 143, "sp": 143, "11750": 143, "113889": 143, "0365114": 143, "628370": 143, "920811": 143, "237153": 143, "853320": 143, "00327447": 143, "819702": 143, "905661": 143, "255611": 143, "292": 143, "un6311gss": 143, "z6311gss": 143, "00189515": 143, "0143859": 143, "0707320": 143, "2400010": 143, "5947970": 143, "2808020": 143, "11427": 143, "00180093": 143, "1722": 143, "350": 143, "0137419": 143, "0681334": 143, "1390": [143, 156], "2333250": 143, "60260": 143, "5890860": 143, "919010": 143, "2995050": 143, "44410": 143, "114536": 143, "0354609": 143, "63230": 143, "920512": 143, "237451": 143, "717560": 143, "00337804": 143, "820458": 143, "165450": 143, "321892": 143, "750": 143, "ip_hf": 143, "ip_mp2": 143, "ip_ccsd": 143, "ip_b3lyp": 143, "scfre": 143, "delta_hf": 143, "scfion": 143, "energy_tot": [143, 145], "delta_ccsd": 143, "ccsd_re": 143, "uccsd": 143, "ccsd_ion": 143, "max_cycl": 143, "delta_mp2": 143, "emp2": 143, "uk": 143, "delta_dft": 143, "bv": 143, "orang": 143, "tick": 143, "fortuit": 143, "nonloc": 143, "hf_exc": 143, "hf_blyp": 143, "hf_pbe": 143, "dft_delta": 143, "dft_re": 143, "dft_ion": [143, 144], "h_x": 143, "bxlyp": 143, "s_x": 143, "b_x": 143, "v_l": 143, "e_mo": 143, "pbex": 143, "508": 143, "562": 143, "acheiev": 143, "unproblemat": 143, "ethene_mol_str": 143, "c0": 143, "6660048050": 143, "2278735620": 143, "9228358077": 143, "ecp": [143, 144, 147], "delta_al": 143, "delta_ecp": 143, "stuttgart": 143, "localizatio": 143, "stex": 143, "dual": 143, "worth": 143, "ethene_adc1_0": 143, "ethene_adc1_1": 143, "ethene_adc1_01": 143, "ethene_adc2_0": 143, "ethene_adc2_1": 143, "ethene_adc2_01": 143, "vinyl_adc1_1": 143, "vinyl_adc1_2": 143, "vinyl_adc1_12": 143, "vinyl_adc2_1": 143, "vinyl_adc2_2": 143, "vinyl_adc2_12": 143, "immediatelli": 143, "shot": 143, "problemat": 143, "ammonia": 143, "flavour": [143, 144], "mocktask": 144, "mpi_comm": 144, "559": [144, 145], "cycl": 144, "o_": 144, "p_j": 144, "imom": 144, "unstabl": 144, "aufbau": [144, 148], "corrupt": 144, "mol_ion": 144, "scf_ion_result": 144, "hf_ie": 144, "mp2_g": 144, "mp2_ion": 144, "mp2_ie": 144, "ump2": 144, "dft_g": 144, "dft_ion_result": 144, "dft_ie": 144, "upward": [144, 148], "relav": 144, "ethyl": 144, "trifluoroacet": 144, "esca": 144, "esca_xyz": 144, "1183780041": 144, "3449927563": 144, "0140172822": 144, "2599020293": 144, "9430366372": 144, "0248385056": 144, "4019839124": 144, "0408200726": 144, "0368443870": 144, "8399255955": 144, "1560630574": 144, "0169777359": 144, "8945563482": 144, "0267696528": 144, "1485539196": 144, "7954196415": 144, "0187110930": 144, "0011424145": 144, "0675509573": 144, "8144007049": 144, "0614767265": 144, "7486063992": 144, "4602333713": 144, "1739210991": 144, "1986940727": 144, "1850294900": 144, "1302033614": 144, "3268717284": 144, "1720377773": 144, "5289059043": 144, "6185520565": 144, "8344576449": 144, "1859838788": 144, "3116641442": 144, "1959612359": 144, "1419001202": 144, "7716619472": 144, "1057672384": 144, "0380096706": 144, "6012985602": 144, "5468300237": 144, "5651778685": 144, "esca_i": 144, "302": 144, "295": 144, "293": 144, "277": 144, "arb": 144, "photoabsorpt": 144, "disctinct": 144, "xane": 144, "exaf": 144, "interfer": [144, 149], "condens": 144, "atttenu": 144, "xaf": 144, "remaind": 144, "circumv": 144, "spuriou": 144, "valen": 144, "abot": 144, "533": 144, "543": 144, "71638": [144, 145], "5099": [144, 145], "7967": [144, 145], "6956": [144, 145], "0373": [144, 145, 156], "8087": [144, 145], "49351": [144, 145], "557": [144, 145], "6567": [144, 145], "0099": [144, 145, 156], "7858": [144, 145, 156], "2142": [144, 145, 156], "50482": [144, 145], "9647": [144, 145], "8441": [144, 145], "1559": [144, 145, 156], "rpa_drv": 144, "tdaeigensolv": 144, "decid": 144, "rough": 144, "514": 144, "520": [144, 148], "erron": 144, "mcscf_cpp": 144, "mclr_cppsolver": 144, "set_damp": 144, "set_frequency_rang": 144, "step_siz": 144, "produce_plot": 144, "auger": 144, "biolog": 144, "heavier": [144, 149], "channel": 144, "vtc": 144, "weakest": 144, "mock": 144, "adc_x": [144, 145, 148], "598": 144, "603": 144, "20632": 144, "2647": 144, "9644": 144, "03563": 144, "15933": 144, "9622": 144, "03785": 144, "09183": 144, "1495": [144, 156], "1612": 144, "9588": 144, "04123": 144, "04624": 144, "599": 144, "9086": 144, "1409": [144, 156], "9561": 144, "04391": 144, "disagr": 144, "epsilon_v": [144, 146], "multichannel": 144, "massiv": 144, "n_core": 144, "energy_diff": 144, "mo_c": 144, "y_ao": 144, "y_mo": 144, "z_ao": 144, "z_mo": 144, "65707757": 144, "6878829": 144, "39950787": 144, "70379307": 144, "94953867": 144, "01478": 144, "258": 144, "00238": 144, "04878": 144, "510": 144, "00255": 144, "05050": 144, "708": 144, "00342": 144, "05848": 144, "impress": 144, "disregard": 144, "detun": 144, "trickier": 144, "adc_rx": 144, "adc_rix": 144, "indx": 144, "e_xa": 144, "i_xa": 144, "i_x": 144, "specta": 144, "marker": 144, "tmp": 144, "ok": 144, "markers": [144, 156], "10000": 144, "530": 144, "tdscf": 145, "mp_re": 145, "mp_ion": 145, "ionzat": 145, "scf_re": [145, 148], "similarl": 146, "c2h2f2": 146, "3836545197": 146, "0624718520": 146, "9374006976": 146, "9085904157": 146, "0780878284": 146, "6951077256": 146, "6941077256": 146, "closest": 146, "psi_v": 146, "mayb": 147, "tricki": 147, "Be": 148, "pump": 148, "muliticipl": 148, "lsor": 148, "hsor": 148, "claim": 148, "scf_lsor": 148, "scf_hsor": 148, "adc_g": 148, "adc_lsor": 148, "adc_hsor": 148, "ground_stat": 148, "somo": 148, "40792": 148, "983870205311": 148, "384872592259": 148, "05814060": 148, "01079184": 148, "384686594376": 148, "0001859979": 148, "07420221": 148, "01375784": 148, "03127402": 148, "385180742153": 148, "0004941478": 148, "00038519": 148, "00008834": 148, "01650959": 148, "385180774173": 148, "0000000320": 148, "00007657": 148, "00002027": 148, "00029092": 148, "385180774932": 148, "0000000008": 148, "00000194": 148, "00000051": 148, "00002929": 148, "385180774934": 148, "3851807749": 148, "5413254944": 148, "0000001389": 148, "13379": 148, "01751": 148, "52917": 148, "35661": 148, "29214": 148, "05639": 148, "14625": 148, "80982": 148, "87513": 148, "88918": 148, "11351025": 148, "09818089": 148, "18647630": 148, "09204895": 148, "84616908": 148, "02730824": 148, "11231928": 148, "01012702": 148, "18487023": 148, "84589976": 148, "51e": 148, "20e": 148, "11231840": 148, "00025135": 148, "036994": 148, "053332": 148, "026326": 148, "037908": 148, "054574": 148, "023365": 148, "116020": 148, "051026": 148, "07268": 148, "0174": [148, 153, 156], "522": 148, "04691": 148, "0364": [148, 156], "03444": 148, "0092": [148, 156], "core_1": 148, "9993": 148, "9984": 148, "9986": 148, "useless": 148, "presuppos": 148, "That": 148, "tediou": 148, "xes_rev_": 148, "xes_rev_f": 148, "xes_": 148, "xes_f": 148, "struggl": 149, "argu": 149, "practis": 149, "multilay": 149, "poorer": 149, "intensitit": 149, "src2": 149, "r1": 149, "descipt": 149, "anywai": 149, "x2c": 149, "dougla": 149, "kroll": 149, "notori": 149, "cast": 150, "longrightarrow": 150, "572": 150, "383": 150, "kg": 150, "987": 150, "772": 150, "359": 150, "744": [150, 156], "418": 150, "884": 150, "854": 150, "297": 150, "478": 150, "physical_const": 150, "wien": 150, "1st": 150, "polarizabl": 150, "magn": 150, "flux": 150, "deuteron": 150, "magneton": 150, "neutron": 150, "gyromagn": 150, "anomali": 150, "helion": 150, "muon": 150, "220": 150, "lattic": 150, "mev": 150, "star": 150, "hertz": 150, "meter": 150, "joul": 150, "kilogram": 150, "mag": 150, "hz": 150, "tesla": 150, "imped": 150, "compton": 150, "conduct": 150, "josephson": 150, "von": 150, "klitz": 150, "cu": 150, "gyromag": 150, "radianc": 150, "loschmidt": 150, "273": 150, "kpa": 150, "gravit": 150, "mhz": 150, "fm": 150, "gev": 150, "circul": 150, "hc": 150, "sackur": 150, "tetrod": 150, "graviti": 150, "atmospher": 150, "stefan": 150, "thomson": 150, "triton": 150, "unifi": 150, "um": 150, "amper": 150, "farad": 150, "henri": 150, "ohm": 150, "watt": 150, "hyperfin": 150, "lumin": 150, "efficaci": 150, "hd": 150, "ht": 150, "uncertainti": 150, "054571817e": 150, "602176634e": 150, "1093837015e": 150, "29177210903e": 150, "3597447222071e": 150, "4188843265857e": 150, "au2j": 150, "calori": 150, "au2cm": 150, "au2nm": 150, "0e9": 150, "au2kjmol": 150, "au2kcalmol": 150, "21139": 150, "219474": 150, "56335": 150, "2625": [150, 156], "5095": 150, "contact": 150, "occasion": 150, "breviti": 150, "2113245": 151, "doppler": 151, "homogen": 151, "gamma_k": 151, "ln": 151, "conclus": 153, "1187290000": 153, "7532010000": 153, "4749160000": 153, "adc_stat": 153, "3054352": 153, "311314": 153, "0142": [153, 156], "04089": 153, "3903211": 153, "62118": 153, "9636": 153, "03637": 153, "691": 153, "0451": [153, 156], "0227": [153, 156], "0306": [153, 156], "0253": [153, 156], "0182": [153, 156], "0107": [153, 156], "0598": [153, 156], "0301": [153, 156], "0234": [153, 156], "centroid": 153, "1ddm": 153, "rho_f": 153, "p_state": 153, "state_diffdm": 153, "to_ao_basi": 153, "p_state_ao": 153, "to_ndarrai": 153, "cubegen": 153, "outfil": 153, "water_detachment_": 153, "water_attachment_": 153, "voronoi": 153, "tetrafluoroethen": 153, "tfe": 153, "c2h4_xyz": 153, "6655087212": 153, "2112231877": 153, "9379948213": 153, "c2f4_str": 153, "6665934397": 153, "3499511337": 153, "1743643195": 153, "dist_str": 153, "dimer_4a": 153, "file_nam": [153, 154, 156], "unicod": 153, "x212b": 153, "dimer_10a": 153, "slider": [154, 156], "ipywidget": [154, 156], "read_pdb_fil": 154, "pdb_file": 154, "pdb_file_nam": 154, "bithiophen": 154, "pdb_data": 154, "read_pdb_index": 154, "current_index": [154, 156], "endmdl": 154, "return_view": [154, 156], "pdb_data_i": 154, "widget": [154, 156], "total_step": [154, 156], "intslid": [154, 156], "__main__": [154, 156], "movi": 155, "xyz_fil": 156, "xyz_file_nam": 156, "kahweol_optim": 156, "xyz_data": 156, "read_xyz_index": 156, "readlin": 156, "xyz_data_i": 156, "energy_i": 156, "xtb_hessian_drv": 156, "xtbhessiandriv": 156, "kahweol_xtb_hessian": 156, "kahweol_hessian": 156, "kahweol_dipolegrad": 156, "subsect": 156, "mlecul": 156, "xtb_opt_kahweol": 156, "0057": 156, "mdyne": 156, "4671": 156, "0063": 156, "2048": 156, "2562": 156, "2333": 156, "0412": 156, "0481": 156, "0021": 156, "0344": 156, "0289": 156, "0616": 156, "0208": 156, "0510": 156, "0420": 156, "0461": 156, "0453": 156, "0309": 156, "0166": 156, "0615": 156, "0485": 156, "0058": 156, "0080": 156, "0764": 156, "0153": 156, "0333": 156, "0500": 156, "0074": 156, "0404": 156, "0439": 156, "0423": 156, "0029": 156, "0648": 156, "0230": 156, "0019": 156, "0034": 156, "0343": 156, "0218": 156, "0746": 156, "0215": 156, "0387": 156, "0238": 156, "0195": 156, "0408": 156, "1014": 156, "0422": 156, "0622": 156, "1515": 156, "0200": 156, "0270": 156, "0554": 156, "0061": 156, "0427": 156, "0374": 156, "0607": 156, "0395": 156, "0394": 156, "0491": 156, "0357": 156, "0483": 156, "0015": 156, "0314": 156, "0938": 156, "0180": 156, "0335": 156, "0496": 156, "0095": 156, "0474": 156, "0288": 156, "0538": 156, "0091": 156, "0081": 156, "0318": 156, "0657": 156, "0127": 156, "0680": 156, "0591": 156, "0653": 156, "0704": 156, "0355": 156, "0310": 156, "0577": 156, "2599": 156, "1413": 156, "1615": 156, "0963": 156, "1244": 156, "2222": 156, "0257": 156, "1171": 156, "0313": 156, "0642": 156, "0275": 156, "0468": 156, "0459": 156, "1247": 156, "0690": 156, "3611": 156, "4350": 156, "0557": 156, "0872": 156, "2202": 156, "0821": 156, "2169": 156, "0791": 156, "1585": 156, "2385": 156, "0114": 156, "0385": 156, "1321": 156, "0025": 156, "0478": 156, "0750": 156, "0400": 156, "0745": 156, "0658": 156, "0388": 156, "0290": 156, "0303": 156, "0260": 156, "0800": 156, "0066": 156, "0375": 156, "0454": 156, "0225": 156, "0455": 156, "1243": 156, "0371": 156, "0531": 156, "0353": 156, "0023": 156, "0645": 156, "0049": 156, "1062": 156, "0273": 156, "0822": 156, "0788": 156, "0497": 156, "0096": 156, "0952": 156, "0329": 156, "0621": 156, "1252": 156, "0580": 156, "0294": 156, "1948": 156, "0044": 156, "0488": 156, "0756": 156, "1058": 156, "0399": 156, "0418": 156, "0950": 156, "0098": 156, "0772": 156, "0614": 156, "0526": 156, "0669": 156, "1319": 156, "0694": 156, "0865": 156, "0417": 156, "1622": 156, "0162": 156, "0204": 156, "0941": 156, "1181": 156, "0226": 156, "0327": 156, "0814": 156, "0457": 156, "1076": 156, "0390": 156, "1172": 156, "0629": 156, "0913": 156, "0097": 156, "0207": 156, "0586": 156, "0285": 156, "0716": 156, "1040": 156, "1865": 156, "0150": 156, "1425": 156, "1184": 156, "0246": 156, "1163": 156, "0816": 156, "0542": 156, "0574": 156, "0958": 156, "0087": 156, "1535": 156, "0323": 156, "3299": 156, "0847": 156, "0322": 156, "2865": 156, "6277": 156, "3427": 156, "0917": 156, "0902": 156, "0476": 156, "0262": 156, "1117": 156, "0282": 156, "0347": 156, "0161": 156, "0664": 156, "0569": 156, "0085": 156, "0088": 156, "0084": 156, "0171": 156, "0317": 156, "0075": 156, "0383": 156, "0177": 156, "0368": 156, "0823": 156, "1463": 156, "0086": 156, "0452": 156, "0345": 156, "0986": 156, "1293": 156, "0449": 156, "0935": 156, "0037": 156, "0071": 156, "0299": 156, "1408": 156, "0168": 156, "0683": 156, "1121": 156, "1004": 156, "0961": 156, "0626": 156, "0027": 156, "1033": 156, "0493": 156, "1597": 156, "0998": 156, "0434": 156, "0093": 156, "0447": 156, "0446": 156, "0205": 156, "0392": 156, "1519": 156, "0401": 156, "0563": 156, "1382": 156, "1077": 156, "1741": 156, "1354": 156, "0904": 156, "0467": 156, "2345": 156, "0324": 156, "0089": 156, "0665": 156, "0926": 156, "0495": 156, "1302": 156, "0473": 156, "0365": 156, "0425": 156, "2353": 156, "2530": 156, "0761": 156, "1112": 156, "1529": 156, "2102": 156, "1219": 156, "1378": 156, "1233": 156, "0828": 156, "0578": 156, "1978": 156, "2828": 156, "1578": 156, "4742": 156, "0228": 156, "5238": 156, "0844": 156, "0188": 156, "0316": 156, "1284": 156, "0751": 156, "1712": 156, "0045": 156, "0403": 156, "0337": 156, "0539": 156, "0320": 156, "0528": 156, "0555": 156, "0020": 156, "0120": 156, "0201": 156, "0757": 156, "0494": 156, "0433": 156, "0181": 156, "1242": 156, "0547": 156, "1254": 156, "0073": 156, "1492": 156, "0480": 156, "0305": 156, "0039": 156, "0128": 156, "0035": 156, "0987": 156, "1218": 156, "0280": 156, "0509": 156, "0874": 156, "1452": 156, "0402": 156, "0276": 156, "0210": 156, "0428": 156, "0637": 156, "0967": 156, "0520": 156, "0416": 156, "0471": 156, "0279": 156, "0482": 156, "1765": 156, "0636": 156, "1149": 156, "1876": 156, "1123": 156, "0714": 156, "0231": 156, "0826": 156, "0047": 156, "0604": 156, "0733": 156, "1271": 156, "0695": 156, "0631": 156, "0617": 156, "0079": 156, "1232": 156, "1605": 156, "0882": 156, "0308": 156, "0131": 156, "0916": 156, "2441": 156, "0372": 156, "1340": 156, "2320": 156, "0936": 156, "1257": 156, "0046": 156, "0060": 156, "0639": 156, "1875": 156, "0338": 156, "0989": 156, "2829": 156, "0666": 156, "0297": 156, "4209": 156, "0561": 156, "0708": 156, "0248": 156, "0900": 156, "0469": 156, "0519": 156, "0579": 156, "0212": 156, "0693": 156, "0245": 156, "0272": 156, "0048": 156, "0211": 156, "1086": 156, "0927": 156, "0254": 156, "0090": 156, "0137": 156, "0911": 156, "0659": 156, "0332": 156, "0980": 156, "0646": 156, "0530": 156, "0880": 156, "1028": 156, "0536": 156, "0737": 156, "0799": 156, "0269": 156, "0856": 156, "0556": 156, "1541": 156, "0186": 156, "0787": 156, "0576": 156, "0156": 156, "0463": 156, "0592": 156, "0535": 156, "0263": 156, "0460": 156, "1556": 156, "0834": 156, "0438": 156, "2165": 156, "1914": 156, "0906": 156, "0752": 156, "1249": 156, "0030": 156, "0281": 156, "0611": 156, "0831": 156, "0776": 156, "0050": 156, "1816": 156, "0271": 156, "3007": 156, "1669": 156, "3511": 156, "2545": 156, "0362": 156, "2108": 156, "1327": 156, "0711": 156, "0739": 156, "0252": 156, "0862": 156, "1510": 156, "0172": 156, "0644": 156, "0026": 156, "6984": 156, "2810": 156, "0630": 156, "0379": 156, "0738": 156, "1196": 156, "0300": 156, "0854": 156, "0334": 156, "0221": 156, "0441": 156, "0879": 156, "0503": 156, "0929": 156, "0296": 156, "0760": 156, "1882": 156, "0487": 156, "0676": 156, "1043": 156, "0545": 156, "0078": 156, "0730": 156, "1202": 156, "1070": 156, "0562": 156, "0472": 156, "0470": 156, "0583": 156, "0328": 156, "0249": 156, "0589": 156, "1084": 156, "0809": 156, "0907": 156, "0429": 156, "1301": 156, "0370": 156, "0515": 156, "0672": 156, "2231": 156, "3585": 156, "1867": 156, "3231": 156, "1170": 156, "0770": 156, "0358": 156, "1718": 156, "0933": 156, "0516": 156, "0971": 156, "0352": 156, "1412": 156, "0928": 156, "2206": 156, "0891": 156, "1815": 156, "0304": 156, "162": 156, "1261": 156, "0643": 156, "1522": 156, "1683": 156, "1178": 156, "0663": 156, "1333": 156, "0154": 156, "0763": 156, "0887": 156, "0953": 156, "0522": 156, "0759": 156, "0255": 156, "0424": 156, "0445": 156, "0450": 156, "0748": 156, "0384": 156, "0393": 156, "1756": 156, "0534": 156, "0389": 156, "0572": 156, "0173": 156, "0667": 156, "0492": 156, "0326": 156, "0325": 156, "0062": 156, "0054": 156, "0396": 156, "0100": 156, "1225": 156, "0506": 156, "0331": 156, "0703": 156, "0804": 156, "1278": 156, "0782": 156, "0448": 156, "1008": 156, "1031": 156, "0366": 156, "3096": 156, "1127": 156, "1447": 156, "0342": 156, "0051": 156, "0567": 156, "1128": 156, "0662": 156, "1061": 156, "0846": 156, "1307": 156, "2121": 156, "0440": 156, "1156": 156, "0914": 156, "0974": 156, "1665": 156, "0559": 156, "1385": 156, "1324": 156, "0943": 156, "2201": 156, "0866": 156, "9823": 156, "6575": 156, "0069": 156, "0017": 156, "0223": 156, "0220": 156, "0340": 156, "0582": 156, "0312": 156, "0070": 156, "1134": 156, "0877": 156, "0381": 156, "1197": 156, "0546": 156, "0744": 156, "0283": 156, "0184": 156, "0845": 156, "0566": 156, "0302": 156, "0466": 156, "0723": 156, "0552": 156, "1024": 156, "0603": 156, "0585": 156, "1304": 156, "0558": 156, "1110": 156, "0236": 156, "0250": 156, "0349": 156, "4788": 156, "3545": 156, "2187": 156, "3941": 156, "0056": 156, "1435": 156, "2821": 156, "1205": 156, "0398": 156, "1339": 156, "0771": 156, "1530": 156, "7880": 156, "8579": 156, "0386": 156, "0924": 156, "0820": 156, "0600": 156, "0435": 156, "0006": 156, "0507": 156, "0267": 156, "0677": 156, "0479": 156, "0634": 156, "0618": 156, "0274": 156, "0064": 156, "0853": 156, "0350": 156, "0405": 156, "0169": 156, "0758": 156, "0406": 156, "0532": 156, "0059": 156, "0193": 156, "1032": 156, "0014": 156, "0923": 156, "0247": 156, "0883": 156, "0819": 156, "0475": 156, "1208": 156, "1311": 156, "0360": 156, "0807": 156, "0082": 156, "0010": 156, "1020": 156, "0548": 156, "3872": 156, "3424": 156, "2292": 156, "3259": 156, "1419": 156, "1731": 156, "2188": 156, "0348": 156, "0955": 156, "1246": 156, "1918": 156, "0315": 156, "1611": 156, "0217": 156, "1623": 156, "1331": 156, "6357": 156, "0920": 156, "1934": 156, "2644": 156, "0691": 156, "0224": 156, "0419": 156, "1027": 156, "0768": 156, "0094": 156, "0790": 156, "0251": 156, "0307": 156, "1097": 156, "0610": 156, "0999": 156, "0244": 156, "0141": 156, "1328": 156, "0786": 156, "0930": 156, "0413": 156, "0525": 156, "0937": 156, "2299": 156, "1773": 156, "1203": 156, "0052": 156, "1915": 156, "0729": 156, "0286": 156, "0850": 156, "0571": 156, "1050": 156, "3210": 156, "1963": 156, "3385": 156, "0486": 156, "2109": 156, "1801": 156, "2656": 156, "2477": 156, "7688": 156, "0321": 156, "0124": 156, "0235": 156, "0130": 156, "0160": 156, "0287": 156, "0110": 156, "0241": 156, "0145": 156, "0942": 156, "0940": 156, "0692": 156, "0774": 156, "0284": 156, "1102": 156, "5899": 156, "2695": 156, "4527": 156, "3196": 156, "1763": 156, "3724": 156, "5900": 156, "1095": 156, "1238": 156, "0077": 156, "0295": 156, "0529": 156, "0504": 156, "0594": 156, "0356": 156, "0502": 156, "1668": 156, "0511": 156, "0550": 156, "1291": 156, "1096": 156, "1049": 156, "0995": 156, "0560": 156, "0619": 156, "0718": 156, "1093": 156, "0895": 156, "1107": 156, "1056": 156, "0717": 156, "1092": 156, "1616": 156, "2570": 156, "1560": 156, "3884": 156, "2519": 156, "1750": 156, "2137": 156, "3303": 156, "1433": 156, "0319": 156, "1719": 156, "0962": 156, "0863": 156, "0727": 156, "0829": 156, "0652": 156, "1347": 156, "271": 156, "8846": 156, "8985": 156, "0523": 156, "0851": 156, "0985": 156, "0827": 156, "0498": 156, "0292": 156, "1223": 156, "0219": 156, "1273": 156, "0240": 156, "1154": 156, "0613": 156, "1015": 156, "1735": 156, "0993": 156, "1351": 156, "1207": 156, "1652": 156, "3336": 156, "3128": 156, "0860": 156, "0041": 156, "1349": 156, "1194": 156, "1905": 156, "1179": 156, "1690": 156, "1313": 156, "1276": 156, "1549": 156, "2678": 156, "0533": 156, "8600": 156, "2975": 156, "0415": 156, "0158": 156, "0762": 156, "0410": 156, "0277": 156, "1099": 156, "1724": 156, "1122": 156, "0881": 156, "1053": 156, "1513": 156, "2375": 156, "0775": 156, "1080": 156, "1268": 156, "1475": 156, "0910": 156, "1384": 156, "2660": 156, "1399": 156, "3832": 156, "1637": 156, "1074": 156, "1306": 156, "1847": 156, "0743": 156, "1591": 156, "0701": 156, "0755": 156, "294": 156, "1303": 156, "1600": 156, "0391": 156, "1090": 156, "1446": 156, "0869": 156, "1126": 156, "0040": 156, "0713": 156, "1438": 156, "0330": 156, "1078": 156, "0584": 156, "0996": 156, "2168": 156, "1526": 156, "0684": 156, "0608": 156, "0612": 156, "3182": 156, "1786": 156, "3484": 156, "1217": 156, "1674": 156, "0939": 156, "2420": 156, "1155": 156, "2909": 156, "1734": 156, "1593": 156, "301": 156, "9885": 156, "1603": 156, "0426": 156, "1025": 156, "2216": 156, "0957": 156, "0725": 156, "0908": 156, "0660": 156, "0638": 156, "0901": 156, "1517": 156, "1656": 156, "1350": 156, "0499": 156, "2367": 156, "1133": 156, "1662": 156, "1947": 156, "4000": 156, "1595": 156, "1388": 156, "2117": 156, "1684": 156, "1259": 156, "1429": 156, "319": 156, "1543": 156, "4964": 156, "0136": 156, "1037": 156, "0732": 156, "2135": 156, "0602": 156, "0721": 156, "0697": 156, "0670": 156, "1279": 156, "2093": 156, "1407": 156, "1764": 156, "1290": 156, "0888": 156, "1866": 156, "0778": 156, "0581": 156, "1472": 156, "4060": 156, "1645": 156, "2664": 156, "1323": 156, "0687": 156, "0975": 156, "2243": 156, "2970": 156, "333": 156, "4191": 156, "1584": 156, "8184": 156, "0490": 156, "0517": 156, "0378": 156, "1554": 156, "1383": 156, "0565": 156, "1370": 156, "0773": 156, "3317": 156, "2572": 156, "1023": 156, "2593": 156, "1827": 156, "0728": 156, "2991": 156, "0696": 156, "0789": 156, "1269": 156, "0432": 156, "1514": 156, "0298": 156, "1627": 156, "2148": 156, "0959": 156, "1048": 156, "1255": 156, "1753": 156, "1344": 156, "0979": 156, "357": 156, "8193": 156, "2118": 156, "5148": 156, "0840": 156, "0903": 156, "0668": 156, "0361": 156, "1135": 156, "0553": 156, "0966": 156, "0754": 156, "1111": 156, "0380": 156, "1728": 156, "1811": 156, "1787": 156, "1975": 156, "1736": 156, "0421": 156, "3394": 156, "3037": 156, "1411": 156, "1282": 156, "0797": 156, "1572": 156, "2189": 156, "1164": 156, "1286": 156, "2066": 156, "1294": 156, "0813": 156, "1531": 156, "1289": 156, "0783": 156, "0359": 156, "0661": 156, "0264": 156, "367": 156, "3828": 156, "1199": 156, "1746": 156, "0508": 156, "1227": 156, "0802": 156, "0540": 156, "0068": 156, "1216": 156, "1691": 156, "0875": 156, "0568": 156, "2308": 156, "1485": 156, "1193": 156, "1089": 156, "1455": 156, "2327": 156, "2293": 156, "1045": 156, "0885": 156, "1523": 156, "0899": 156, "1410": 156, "2076": 156, "1667": 156, "1081": 156, "1808": 156, "1509": 156, "3421": 156, "4508": 156, "1369": 156, "0570": 156, "0265": 156, "2030": 156, "1310": 156, "1487": 156, "2097": 156, "2355": 156, "1153": 156, "0649": 156, "2753": 156, "0651": 156, "2711": 156, "1777": 156, "2265": 156, "0724": 156, "7142": 156, "4773": 156, "1343": 156, "0599": 156, "0512": 156, "1391": 156, "3677": 156, "1204": 156, "2897": 156, "3020": 156, "0982": 156, "1330": 156, "3690": 156, "0988": 156, "0769": 156, "0960": 156, "1348": 156, "1298": 156, "416": 156, "9117": 156, "4005": 156, "4654": 156, "1617": 156, "0719": 156, "0377": 156, "0671": 156, "0376": 156, "1066": 156, "0012": 156, "1285": 156, "1635": 156, "1320": 156, "0884": 156, "1106": 156, "3551": 156, "1168": 156, "1896": 156, "1145": 156, "2630": 156, "0859": 156, "1088": 156, "0981": 156, "0605": 156, "1952": 156, "1332": 156, "0835": 156, "0458": 156, "0686": 156, "0674": 156, "1251": 156, "0590": 156, "1483": 156, "1524": 156, "2144": 156, "0951": 156, "0736": 156, "0430": 156, "0896": 156, "434": 156, "4452": 156, "2715": 156, "8699": 156, "0702": 156, "0185": 156, "0931": 156, "1870": 156, "1749": 156, "1228": 156, "1006": 156, "0753": 156, "1682": 156, "2055": 156, "1147": 156, "0973": 156, "1010": 156, "1778": 156, "0994": 156, "3641": 156, "447": 156, "5920": 156, "3056": 156, "5629": 156, "0984": 156, "0735": 156, "3579": 156, "1834": 156, "2323": 156, "0803": 156, "1260": 156, "2548": 156, "0722": 156, "1695": 156, "0336": 156, "1359": 156, "0810": 156, "3326": 156, "1428": 156, "1069": 156, "0842": 156, "0836": 156, "1392": 156, "2479": 156, "5590": 156, "3112": 156, "2901": 156, "0792": 156, "0544": 156, "0537": 156, "0409": 156, "0841": 156, "1085": 156, "1059": 156, "0894": 156, "2159": 156, "0838": 156, "1739": 156, "1214": 156, "1114": 156, "1368": 156, "1545": 156, "0706": 156, "0886": 156, "3199": 156, "2958": 156, "1702": 156, "475": 156, "4137": 156, "1883": 156, "0587": 156, "0521": 156, "3607": 156, "2134": 156, "4165": 156, "2321": 156, "5989": 156, "4980": 156, "1177": 156, "1404": 156, "0734": 156, "0817": 156, "1221": 156, "1030": 156, "0991": 156, "1767": 156, "1943": 156, "1042": 156, "1336": 156, "1486": 156, "2034": 156, "1807": 156, "2115": 156, "1420": 156, "1533": 156, "2500": 156, "3464": 156, "1570": 156, "0632": 156, "1140": 156, "1220": 156, "523": 156, "4464": 156, "5574": 156, "6264": 156, "0700": 156, "0849": 156, "1468": 156, "0767": 156, "1467": 156, "0444": 156, "1521": 156, "0867": 156, "1005": 156, "3130": 156, "1459": 156, "1869": 156, "0673": 156, "1482": 156, "2552": 156, "0781": 156, "3561": 156, "8354": 156, "9724": 156, "0970": 156, "0815": 156, "1256": 156, "0912": 156, "0839": 156, "2516": 156, "1372": 156, "1104": 156, "1241": 156, "1396": 156, "1120": 156, "2306": 156, "1192": 156, "1707": 156, "1432": 156, "1423": 156, "2322": 156, "1537": 156, "561": 156, "3221": 156, "6160": 156, "4850": 156, "0949": 156, "1445": 156, "1398": 156, "1022": 156, "1198": 156, "2044": 156, "1784": 156, "2483": 156, "0965": 156, "1151": 156, "1678": 156, "1966": 156, "3110": 156, "1373": 156, "0808": 156, "1881": 156, "1850": 156, "592": 156, "3268": 156, "4681": 156, "0793": 156, "0825": 156, "0443": 156, "1774": 156, "2469": 156, "1414": 156, "1449": 156, "1448": 156, "0806": 156, "1108": 156, "0640": 156, "1838": 156, "1912": 156, "0889": 156, "1709": 156, "0675": 156, "3057": 156, "1052": 156, "1939": 156, "1916": 156, "1624": 156, "1209": 156, "1287": 156, "1789": 156, "1427": 156, "1536": 156, "1186": 156, "1060": 156, "0549": 156, "0919": 156, "1360": 156, "1091": 156, "1892": 156, "1431": 156, "2312": 156, "5925": 156, "8355": 156, "8257": 156, "1300": 156, "1814": 156, "1715": 156, "1456": 156, "0726": 156, "0593": 156, "1721": 156, "2582": 156, "2167": 156, "2680": 156, "2082": 156, "2298": 156, "1493": 156, "1129": 156, "2663": 156, "1477": 156, "1157": 156, "1821": 156, "640": 156, "4940": 156, "9998": 156, "1240": 156, "0848": 156, "1944": 156, "1805": 156, "2526": 156, "0785": 156, "1544": 156, "1187": 156, "1190": 156, "2434": 156, "1744": 156, "0990": 156, "1342": 156, "1686": 156, "1353": 156, "1051": 156, "1401": 156, "2456": 156, "0843": 156, "3364": 156, "1159": 156, "654": 156, "9098": 156, "9867": 156, "7875": 156, "1169": 156, "1430": 156, "1512": 156, "1680": 156, "1158": 156, "1841": 156, "0969": 156, "0625": 156, "1673": 156, "1034": 156, "1959": 156, "1115": 156, "1465": 156, "2281": 156, "1857": 156, "1878": 156, "2164": 156, "0805": 156, "1316": 156, "1083": 156, "1823": 156, "3685": 156, "9313": 156, "1162": 156, "0858": 156, "1855": 156, "1853": 156, "0747": 156, "0382": 156, "0784": 156, "2978": 156, "1566": 156, "2748": 156, "0720": 156, "1400": 156, "3201": 156, "2403": 156, "1318": 156, "6430": 156, "8629": 156, "3222": 156, "0978": 156, "1478": 156, "1908": 156, "1598": 156, "0740": 156, "0878": 156, "3569": 156, "2908": 156, "3341": 156, "749": 156, "3389": 156, "4426": 156, "9208": 156, "1283": 156, "2569": 156, "9077": 156, "778": 156, "7937": 156, "9971": 156, "3176": 156, "1877": 156, "1479": 156, "1100": 156, "2057": 156, "1771": 156, "0909": 156, "1322": 156, "2284": 156, "1375": 156, "3376": 156, "3146": 156, "3487": 156, "0655": 156, "1473": 156, "779": 156, "9040": 156, "6813": 156, "1729": 156, "0873": 156, "2336": 156, "6529": 156, "4468": 156, "2968": 156, "6436": 156, "1371": 156, "1416": 156, "0681": 156, "1265": 156, "2033": 156, "1263": 156, "1568": 156, "1989": 156, "2185": 156, "2051": 156, "1361": 156, "1500": 156, "3189": 156, "1395": 156, "9631": 156, "2888": 156, "1166": 156, "1520": 156, "1557": 156, "0780": 156, "0796": 156, "2775": 156, "1018": 156, "1518": 156, "1923": 156, "2861": 156, "1046": 156, "1125": 156, "1859": 156, "2436": 156, "2594": 156, "1620": 156, "1879": 156, "832": 156, "4849": 156, "9463": 156, "1009": 156, "1950": 156, "8546": 156, "2256": 156, "9124": 156, "6975": 156, "2059": 156, "1054": 156, "1012": 156, "1516": 156, "1352": 156, "1183": 156, "1314": 156, "0709": 156, "6612": 156, "857": 156, "9266": 156, "8706": 156, "1176": 156, "2264": 156, "2103": 156, "1820": 156, "2952": 156, "2089": 156, "3350": 156, "1663": 156, "1845": 156, "3075": 156, "2305": 156, "1067": 156, "883": 156, "9069": 156, "8774": 156, "0976": 156, "2431": 156, "2790": 156, "1998": 156, "1345": 156, "2230": 156, "1270": 156, "2063": 156, "1919": 156, "0710": 156, "1440": 156, "2729": 156, "891": 156, "3866": 156, "6498": 156, "1830": 156, "0922": 156, "2279": 156, "2156": 156, "4838": 156, "2512": 156, "6614": 156, "893": 156, "4473": 156, "8621": 156, "0932": 156, "0833": 156, "1036": 156, "1234": 156, "2597": 156, "2961": 156, "4241": 156, "1003": 156, "1453": 156, "2484": 156, "1402": 156, "1848": 156, "2913": 156, "4893": 156, "1029": 156, "0898": 156, "1813": 156, "1812": 156, "2280": 156, "3183": 156, "2173": 156, "1726": 156, "2062": 156, "2514": 156, "1696": 156, "1793": 156, "1213": 156, "910": 156, "1235": 156, "1614": 156, "0983": 156, "3847": 156, "2677": 156, "5068": 156, "2208": 156, "1079": 156, "1646": 156, "2179": 156, "931": 156, "2071": 156, "9230": 156, "1280": 156, "2669": 156, "2873": 156, "1299": 156, "1880": 156, "0954": 156, "1507": 156, "3195": 156, "3087": 156, "1236": 156, "1547": 156, "3234": 156, "1953": 156, "9628": 156, "3819": 156, "1334": 156, "2427": 156, "0688": 156, "1150": 156, "1575": 156, "2326": 156, "1885": 156, "1590": 156, "2347": 156, "2398": 156, "2675": 156, "1551": 156, "2092": 156, "7155": 156, "9110": 156, "0484": 156, "1272": 156, "0855": 156, "2520": 156, "2053": 156, "5364": 156, "1872": 156, "2236": 156, "1175": 156, "968": 156, "9913": 156, "7962": 156, "1222": 156, "2712": 156, "1737": 156, "2466": 156, "0977": 156, "1138": 156, "1837": 156, "1588": 156, "2154": 156, "1250": 156, "2128": 156, "1563": 156, "1041": 156, "1648": 156, "996": 156, "4610": 156, "0948": 156, "2543": 156, "0678": 156, "3772": 156, "2550": 156, "2273": 156, "2080": 156, "1655": 156, "2847": 156, "1173": 156, "8326": 156, "1374": 156, "1610": 156, "2609": 156, "1562": 156, "1573": 156, "4082": 156, "0864": 156, "1109": 156, "7049": 156, "3247": 156, "3313": 156, "2412": 156, "1788": 156, "1874": 156, "1182": 156, "1450": 156, "1783": 156, "1752": 156, "2349": 156, "1064": 156, "1711": 156, "2921": 156, "1548": 156, "2064": 156, "2087": 156, "2354": 156, "3352": 156, "3725": 156, "1802": 156, "2229": 156, "1687": 156, "2994": 156, "1264": 156, "1564": 156, "2129": 156, "2468": 156, "0779": 156, "2077": 156, "1565": 156, "1973": 156, "0852": 156, "1142": 156, "3933": 156, "9101": 156, "4516": 156, "0956": 156, "4064": 156, "2334": 156, "1501": 156, "2351": 156, "1840": 156, "3560": 156, "0699": 156, "1038": 156, "1480": 156, "2290": 156, "2509": 156, "1659": 156, "1124": 156, "5706": 156, "7579": 156, "2527": 156, "1174": 156, "2454": 156, "2172": 156, "2083": 156, "2207": 156, "2204": 156, "0682": 156, "1534": 156, "2429": 156, "2147": 156, "2914": 156, "9201": 156, "3165": 156, "6129": 156, "1650": 156, "1909": 156, "6896": 156, "2198": 156, "5010": 156, "2461": 156, "3145": 156, "3307": 156, "2268": 156, "2212": 156, "4013": 156, "2124": 156, "1137": 156, "1772": 156, "1893": 156, "1825": 156, "9979": 156, "3471": 156, "1606": 156, "1144": 156, "3689": 156, "2472": 156, "2539": 156, "8228": 156, "1921": 156, "3180": 156, "1394": 156, "0972": 156, "2184": 156, "3094": 156, "3015": 156, "1113": 156, "9475": 156, "4222": 156, "1938": 156, "2357": 156, "1379": 156, "2432": 156, "3193": 156, "1658": 156, "2659": 156, "3506": 156, "6241": 156, "1928": 156, "3577": 156, "1454": 156, "1105": 156, "2079": 156, "1653": 156, "5942": 156, "3800": 156, "8966": 156, "1451": 156, "3720": 156, "2223": 156, "1505": 156, "2902": 156, "7484": 156, "2598": 156, "1962": 156, "1503": 156, "1884": 156, "3055": 156, "3623": 156, "3379": 156, "5372": 156, "3906": 156, "1657": 156, "1599": 156, "2518": 156, "1628": 156, "1681": 156, "2313": 156, "2260": 156, "1466": 156, "2523": 156, "3334": 156, "2035": 156, "1769": 156, "1569": 156, "1954": 156, "2418": 156, "4758": 156, "1833": 156, "1229": 156, "1633": 156, "8815": 156, "5111": 156, "7459": 156, "3154": 156, "1717": 156, "2239": 156, "2540": 156, "2622": 156, "1026": 156, "1819": 156, "4625": 156, "5336": 156, "1634": 156, "3513": 156, "1281": 156, "3700": 156, "3217": 156, "2397": 156, "1976": 156, "2358": 156, "4201": 156, "9819": 156, "8888": 156, "1136": 156, "0893": 156, "1576": 156, "1057": 156, "2529": 156, "2591": 156, "3651": 156, "2096": 156, "2027": 156, "1317": 156, "1245": 156, "2898": 156, "1188": 156, "9405": 156, "6393": 156, "2155": 156, "1068": 156, "0897": 156, "2904": 156, "2488": 156, "2701": 156, "1426": 156, "1676": 156, "1075": 156, "1439": 156, "1907": 156, "1742": 156, "4679": 156, "2451": 156, "1389": 156, "1502": 156, "1499": 156, "3159": 156, "1904": 156, "3446": 156, "2603": 156, "2899": 156, "1666": 156, "5694": 156, "3279": 156, "2396": 156, "2510": 156, "1638": 156, "2054": 156, "1329": 156, "1785": 156, "2803": 156, "2903": 156, "2277": 156, "1553": 156, "2196": 156, "9767": 156, "7245": 156, "2806": 156, "1649": 156, "1732": 156, "1692": 156, "1355": 156, "5263": 156, "1791": 156, "4293": 156, "1258": 156, "8761": 156, "2990": 156, "1561": 156, "1782": 156, "1679": 156, "2415": 156, "2580": 156, "1540": 156, "1661": 156, "3566": 156, "1580": 156, "3794": 156, "7383": 156, "1596": 156, "1546": 156, "1574": 156, "1581": 156, "2332": 156, "3765": 156, "3188": 156, "8794": 156, "1670": 156, "1365": 156, "2056": 156, "2918": 156, "3626": 156, "1267": 156, "9597": 156, "1852": 156, "1275": 156, "1019": 156, "5797": 156, "2651": 156, "2130": 156, "2133": 156, "7411": 156, "6580": 156, "2505": 156, "2455": 156, "3022": 156, "2342": 156, "4762": 156, "9353": 156, "3358": 156, "2578": 156, "2681": 156, "4388": 156, "1651": 156, "3619": 156, "0731": 156, "1538": 156, "3082": 156, "7281": 156, "6770": 156, "6003": 156, "3568": 156, "1422": 156, "2036": 156, "1639": 156, "1828": 156, "4476": 156, "2060": 156, "2296": 156, "5744": 156, "5555": 156, "8638": 156, "2987": 156, "1296": 156, "5150": 156, "2636": 156, "1044": 156, "2668": 156, "4124": 156, "4089": 156, "6681": 156, "1461": 156, "3172": 156, "2546": 156, "1335": 156, "1274": 156, "2161": 156, "1444": 156, "7899": 156, "7897": 156, "7775": 156, "1481": 156, "1315": 156, "3207": 156, "5505": 156, "2757": 156, "6465": 156, "6654": 156, "4002": 156, "2295": 156, "2558": 156, "2101": 156, "3994": 156, "1945": 156, "3655": 156, "2139": 156, "3009": 156, "3402": 156, "9654": 156, "1604": 156, "1949": 156, "4243": 156, "3728": 156, "4912": 156, "5603": 156, "2391": 156, "4814": 156, "2374": 156, "3065": 156, "1640": 156, "3366": 156, "2835": 156, "2311": 156, "4539": 156, "5379": 156, "6872": 156, "0777": 156, "4620": 156, "4871": 156, "2362": 156, "2025": 156, "1799": 156, "7611": 156, "9916": 156, "3337": 156, "2949": 156, "2892": 156, "1579": 156, "3045": 156, "4221": 156, "5256": 156, "4094": 156, "2885": 156, "1844": 156, "5789": 156, "2676": 156, "3602": 156, "1230": 156, "9581": 156, "7125": 156, "3085": 156, "2317": 156, "3238": 156, "2739": 156, "2947": 156, "2827": 156, "1358": 156, "9336": 156, "1248": 156, "2049": 156, "2653": 156, "4481": 156, "2394": 156, "2874": 156, "3354": 156, "3892": 156, "5136": 156, "5697": 156, "3792": 156, "1131": 156, "2934": 156, "3362": 156, "2255": 156, "2761": 156, "2686": 156, "2269": 156, "1504": 156, "3733": 156, "5277": 156, "2721": 156, "4772": 156, "2708": 156, "4001": 156, "3070": 156, "1621": 156, "1376": 156, "3535": 156, "5113": 156, "9987": 156, "1642": 156, "1470": 156, "2301": 156, "4283": 156, "9179": 156, "5283": 156, "2875": 156, "4286": 156, "8421": 156, "5164": 156, "2324": 156, "2214": 156, "3722": 156, "3005": 156, "3503": 156, "2759": 156, "3591": 156, "9733": 156, "1895": 156, "3406": 156, "5027": 156, "3192": 156, "6345": 156, "4682": 156, "4493": 156, "2997": 156, "3512": 156, "2078": 156, "4028": 156, "7613": 156, "2568": 156, "2565": 156, "4144": 156, "5070": 156, "6881": 156, "3024": 156, "1210": 156, "3034": 156, "2776": 156, "2881": 156, "2291": 156, "3423": 156, "4694": 156, "1484": 156, "4389": 156, "8141": 156, "1224": 156, "1366": 156, "2276": 156, "3101": 156, "3654": 156, "4071": 156, "2882": 156, "1418": 156, "4298": 156, "1065": 156, "2877": 156, "5179": 156, "5543": 156, "1130": 156, "1496": 156, "6510": 156, "2382": 156, "1762": 156, "4154": 156, "1770": 156, "2045": 156, "3625": 156, "2151": 156, "2414": 156, "4538": 156, "2370": 156, "1946": 156, "3044": 156, "4083": 156, "4442": 156, "2052": 156, "2046": 156, "4503": 156, "7467": 156, "2584": 156, "2439": 156, "2141": 156, "0712": 156, "5299": 156, "3573": 156, "113": 156, "4533": 156, "9856": 156, "2445": 156, "3249": 156, "0870": 156, "2685": 156, "1974": 156, "4661": 156, "8051": 156, "2234": 156, "6934": 156, "4232": 156, "4883": 156, "3232": 156, "1632": 156, "3225": 156, "9585": 156, "8791": 156, "5792": 156, "5831": 156, "1755": 156, "2833": 156, "9955": 156, "9945": 156, "2884": 156, "2657": 156, "9404": 156, "9825": 156, "2891": 156, "8557": 156, "2855": 156, "3756": 156, "8749": 156, "2925": 156, "6034": 156, "7855": 156, "2954": 156, "6781": 156, "9088": 156, "2962": 156, "6422": 156, "8414": 156, "2440": 156, "3600": 156, "2175": 156, "3564": 156, "6120": 156, "3244": 156, "2971": 156, "3311": 156, "5827": 156, "3422": 156, "4970": 156, "123": 156, "2976": 156, "7299": 156, "9351": 156, "2067": 156, "3407": 156, "4988": 156, "4304": 156, "2716": 156, "2613": 156, "124": 156, "2977": 156, "6165": 156, "3219": 156, "4613": 156, "2935": 156, "3343": 156, "3683": 156, "5333": 156, "2979": 156, "6181": 156, "4807": 156, "7254": 156, "2986": 156, "5269": 156, "1550": 156, "3169": 156, "4892": 156, "5439": 156, "4939": 156, "127": 156, "2996": 156, "6772": 156, "3288": 156, "5034": 156, "2932": 156, "3508": 156, "4666": 156, "2999": 156, "6994": 156, "5329": 156, "2286": 156, "3558": 156, "5298": 156, "2448": 156, "3955": 156, "6215": 156, "1441": 156, "3881": 156, "5157": 156, "4898": 156, "5257": 156, "6535": 156, "9204": 156, "2730": 156, "3656": 156, "7877": 156, "1555": 156, "3030": 156, "7906": 156, "4916": 156, "4707": 156, "8630": 156, "3036": 156, "8981": 156, "1775": 156, "9416": 156, "9798": 156, "5328": 156, "7300": 156, "2065": 156, "3063": 156, "7990": 156, "2984": 156, "2700": 156, "1508": 156, "2381": 156, "6543": 156, "3076": 156, "9594": 156, "8717": 156, "2183": 156, "6194": 156, "1469": 156, "3613": 156, "2258": 156, "3086": 156, "6432": 156, "4630": 156, "3900": 156, "6269": 156, "2785": 156, "1693": 156, "2592": 156, "2985": 156, "2145": 156, "3166": 156, "3863": 156, "5855": 156, "3861": 156, "8559": 156, "2094": 156, "3184": 156, "5343": 156, "7513": 156, "8897": 156, "3525": 156, "8055": 156, "5515": 156, "8221": 156, "3530": 156, "8225": 156, "8787": 156, "5092": 156, "wvn": 156, "wvng": 156, "irg": 156, "vibration_view": 156, "ir_inten": 156, "no_norm_mod": 156, "thymin": 157, "thymine_xyz": [157, 159], "095722": [157, 159], "037785": [157, 159], "093615": [157, 159], "011848": [157, 159], "408694": [157, 159], "113404": [157, 159], "204706": [157, 159], "048475": [157, 159], "052807": [157, 159], "302595": [157, 159], "390520": [157, 159], "249226": [157, 159], "214596": [157, 159], "023933": [157, 159], "378238": [157, 159], "017387": [157, 159], "607231": [157, 159], "171757": [157, 159], "270287": [157, 159], "735594": [157, 159], "076393": [157, 159], "098029": [157, 159], "096194": [157, 159], "424990": [157, 159], "052976": [157, 159], "874860": [157, 159], "891573": [157, 159], "002157": [157, 159], "170639": [157, 159], "310554": [157, 159], "671531": [157, 159], "743694": [157, 159], "104794": [157, 159], "301905": [157, 159], "554734": [157, 159], "440234": [157, 159], "292790": [157, 159], "119685": [157, 159], "106201": [157, 159], "053626": [157, 159], "612452": [157, 159], "215637": [157, 159], "446827": [157, 159], "892203": [157, 159], "107092": [157, 159], "volumetr": 157, "gen_cub": 157, "cube_dict": 157, "water_homo": 157, "water_lumo": 157, "water_a_dens": 157, "overlai": 157, "server": 157, "strick": 157, "mo_1": 157, "mo_2": 157, "mo_2p_1": 157, "mo_2p_2": 157, "mo_2p_3": 157, "2p_1": 157, "2p_2": 157, "2p_3": 157, "rad_den_1": 157, "rad_den_2": 157, "rad_den_2p": 157, "subshel": 157, "xrd": 159, "photosystem": 159, "queri": 159, "6w1o": 159, "cartoon": 159, "addstyl": 159, "cartoonish": 159, "strand": 159, "ribbon": 159, "manganes": 159, "calcium": 159, "sigma_j": [], "sigma_b": [], "b1": 86, "70044182e": [], "56150602e": [], "10345571e": [], "15522514e": [], "30146331e": [], "99772127e": [], "39047427e": [], "53094040e": [], "11732022e": [], "47382956e": [], "10397126e": [], "62878536e": [], "03013639e": [], "77028955e": [], "02803164e": [], "29492384e": [], "14491548e": [], "95880701e": [], "60357283e": [], "02002681e": [], "63477216e": [], "08027332e": [], "60693759e": [], "06166779e": [], "27555344e": [], "46504516e": [], "47289562e": [], "95010181e": [], "36845063e": [], "64296092e": [], "47476351e": [], "21901604e": [], "06518883e": [], "30358806e": [], "64737227e": [], "10790568e": [], "74380699e": [], "03984069e": [], "59216448e": [], "57225836e": [], "0j": [], "0270044182091009": [], "electric_dipol": 86, "56032976e": [], "10615002e": [], "40555994e": [], "38925486e": [], "07332712e": [], "00817015e": [], "13074547e": [], "81087785e": [], "08052768e": [], "12729710e": [], "45466896e": [], "44399180e": [], "41074775e": [], "56084913e": [], "10072192e": [], "40258958e": [], "27324992e": [], "07014695e": [], "96490165e": [], "12747250e": [], "00710917e": [], "09998227e": [], "07009519e": [], "46929798e": [], "50062613e": [], "47224873e": [], "48351857e": [], "64898746e": [], "09414829e": [], "60665282e": [], "18679500e": [], "98494415e": [], "22489962e": [], "21381762e": [], "06014225e": [], "07252962e": [], "ndim": 86, "e2_ref": 86, "conj": 86, "b1_ref": 86, "nameerror": [], "traceback": [], "61661005e": [], "03746199e": [], "15254468e": [], "28651384e": [], "68699343e": [], "lrs_result": 86, "84611698e": [], "52830782e": [], "96457295e": [], "15586302e": [], "05423980e": [], "34024945": 86, "36669362": 86, "76493335": 86, "70960170": 86, "21128138": 86, "n_ref": 86, "a1": 86, "298489": 86}, "objects": {}, "objtypes": {}, "objnames": {}, "titleterms": {"us": [0, 33, 133, 157], "jupyt": 0, "notebook": [0, 42], "cell": 0, "type": [0, 133], "markdown": 0, "code": 0, "python": [0, 17], "ecosystem": 0, "molecular": [0, 13, 18, 25, 26, 49, 53, 63, 82, 83, 91, 125, 137, 139, 147, 155, 157, 159], "structur": [0, 57, 65, 72, 128, 133, 137, 138, 139, 152, 155, 159], "visual": [0, 4, 13, 65, 94, 125, 136, 137, 153], "electron": [0, 3, 4, 17, 25, 26, 29, 30, 31, 79, 86, 88, 89, 97, 113, 128, 137, 149, 150, 152, 153], "perform": 0, "scf": [0, 7, 13, 14, 15, 39, 65, 111, 131, 137, 144], "calcul": [0, 7, 10, 14, 33, 38, 39, 65, 70, 72, 81, 83, 90, 94, 115, 126, 132, 136, 144, 148, 151], "orbit": [0, 3, 13, 24, 25, 26, 30, 38, 94, 97, 125, 137, 143, 150, 153, 157], "basi": [0, 3, 4, 10, 14, 15, 22, 26, 81, 89, 128, 143, 146, 149], "set": [0, 4, 7, 10, 26, 58, 65, 81, 89, 128, 143, 146, 149], "effect": [0, 143, 149], "list": 0, "plot": [0, 2, 81, 99, 125], "result": [0, 83, 89, 106, 148], "potenti": [0, 17, 22, 33, 35, 52, 62, 100, 135], "energi": [0, 2, 4, 8, 14, 15, 17, 22, 27, 29, 33, 39, 46, 52, 65, 72, 80, 81, 83, 86, 87, 112, 113, 136, 148], "surfac": [0, 52], "construct": [0, 52, 68, 70, 140], "pe": [0, 51, 52], "interpol": [0, 51, 52], "spline": 0, "fit": [0, 47, 62], "harmon": [0, 47, 66], "function": [0, 2, 5, 11, 19, 20, 26, 30, 32, 38, 86, 88, 89, 99, 118, 143, 150], "exampl": [0, 21, 81, 82, 83], "einstein": 0, "summat": 0, "ao": [0, 10, 14, 15, 17], "mo": [0, 17, 22, 144, 145], "transform": [0, 17, 30, 38, 45, 52], "eigenvalu": [0, 10], "eigenvector": [0, 142], "dictionari": 0, "isinst": 0, "np": 0, "zero": 0, "ones": 0, "rad2deg": 0, "deg2rad": 0, "extern": [0, 99], "websit": 0, "tutori": 0, "how": 1, "cite": 1, "contact": 1, "avail": 2, "xc": [2, 7], "hartre": [2, 10, 12, 15, 22, 33, 85], "fock": [2, 7, 10, 12, 15, 17, 22, 29, 33, 85], "mp2": [2, 22, 33, 46], "fci": 2, "dft": [2, 20, 46, 49, 104, 124, 137, 143, 144, 145, 147], "configur": [3, 33, 75], "interact": [3, 7, 8, 33, 47, 75, 143], "gener": [3, 9, 10, 19, 56, 97, 103], "theori": [3, 5, 8, 15, 20, 21, 27, 32, 64, 82, 91, 111], "The": [3, 21, 22, 52, 70, 144, 146], "n": [3, 16, 30], "ci": [3, 46, 75], "hamiltonian": [3, 17, 25, 29, 81], "direct": [3, 14], "densiti": [3, 4, 5, 18, 19, 20, 28, 29, 30, 33, 38, 49, 70, 153, 157], "matric": [3, 38, 70, 150], "natur": [3, 24, 94, 153], "truncat": [3, 75], "restrict": [3, 24, 122, 148], "excit": [3, 31, 46, 70, 72, 81, 86, 97, 107, 113, 143, 148, 153], "size": [3, 22, 27, 72], "consist": [3, 21, 22, 72, 150], "correl": [4, 8, 19, 20, 21, 89, 120], "One": [4, 17, 25, 28, 29, 33], "particl": [4, 28, 29, 30, 33], "two": [4, 17, 25, 28, 29, 82, 99, 117, 144, 150], "cusp": 4, "converg": [4, 14], "first": [6, 27, 38, 46, 84, 98], "order": [6, 17, 26, 27, 38, 46, 49, 76, 82, 84, 86, 98], "properti": [6, 37, 38, 46, 49, 61, 72, 82, 83, 84, 86, 91, 113, 158], "numer": [6, 27, 33, 46, 49, 83], "integr": [6, 14, 17, 18, 22, 55, 150], "analyt": [6, 46, 49, 99], "optim": [7, 13, 14, 44, 57, 60, 65, 101, 131, 133, 136, 137, 139, 156], "up": [7, 65, 81], "system": [7, 14, 25, 31, 45, 72, 99, 133, 143, 147], "refer": [7, 10, 14, 22, 38, 39, 67, 70, 72, 94, 97, 115, 122, 143, 148], "contribut": [7, 79, 82, 125, 142], "matrix": [7, 10, 17, 25, 26, 33, 70, 72, 113], "procedur": [7, 15], "self": [7, 21, 143], "error": [7, 143], "dispers": [8, 76, 98, 99], "long": 8, "rang": [8, 19], "perturb": [8, 22, 27, 38, 49, 88], "aspect": [9, 56, 98, 103, 143], "diagon": [10, 70], "equat": [10, 15, 19, 27, 49, 86, 100, 113], "solv": [10, 27], "problem": 10, "standard": [10, 148], "case": 10, "non": [10, 39, 47, 143, 148], "linear": [10, 17, 26, 74, 82, 86, 89, 90, 109], "depend": [10, 83, 88, 91, 96, 104, 125, 142], "overlap": [10, 17, 26, 113, 144], "orthogon": [10, 38], "symmetri": [11, 63, 97, 98, 122], "activ": [11, 65, 131], "passiv": 11, "point": [11, 18], "view": 11, "invari": 11, "observ": [11, 88, 99], "oper": [11, 25, 28, 29, 39, 86, 88], "group": 11, "charact": 11, "tabl": 11, "c_": 11, "mathsf": 11, "2v": 11, "2h": 11, "d_": 11, "wave": [11, 26, 30, 32, 118, 143, 150], "hf": [13, 33, 46, 49, 72, 139, 143], "veloxchem": [13, 43, 76, 88, 89, 98, 100, 106], "defin": [13, 99, 100], "molecul": [13, 26, 59, 65, 81], "inform": [13, 26], "some": 14, "paramet": [14, 86, 87, 96], "get": [14, 43, 81], "measur": [14, 89, 126, 147], "iter": 14, "acceler": 14, "invers": 14, "subspac": 14, "lagrangian": 15, "canon": [15, 55], "form": 15, "In": [15, 76, 89, 98, 111], "koopman": [15, 144, 145], "theorem": [15, 16, 108, 144, 145], "brillouin": 15, "roothaan": 15, "hall": 15, "scheme": 15, "hohenberg": 16, "kohn": [16, 19], "hk": 16, "i": [16, 144, 145], "ii": 16, "represent": [16, 72], "exposur": 17, "layer": 17, "kinet": 17, "nuclear": [17, 79], "momentum": 17, "electr": [17, 76, 82, 84, 88, 89, 91, 98, 113], "dipol": [17, 33, 38, 39, 76, 78, 81, 82, 83, 84, 89, 98, 113], "moment": [17, 33, 38, 39, 83, 84, 89], "magnet": 17, "repuls": 17, "convent": 17, "driven": 17, "kernel": 18, "grid": 18, "sham": 19, "method": [19, 21, 23, 60, 65, 72, 83, 93, 100, 118, 122, 143, 144, 145, 149], "exchang": 19, "local": [19, 37, 38, 42, 143], "approxim": [19, 25, 33, 108, 115, 146], "lda": 19, "gradient": [19, 46, 48, 60, 61, 65, 86, 113], "gga": 19, "meta": 19, "mgga": 19, "hybrid": 19, "separ": [19, 69, 106], "known": 19, "defici": 19, "mc": 20, "pdft": 20, "strong": [20, 21], "pair": 20, "multiconfigur": [20, 21], "mcscf": [21, 33, 101, 124], "static": [21, 91, 120], "field": [21, 47, 62, 82, 83, 88, 91, 96, 99, 133, 136], "illustr": [21, 22, 27, 28, 29, 86, 88, 90, 97], "implement": [21, 60, 71, 81, 94, 110], "multirefer": [21, 23, 93], "m\u00f8ller": 22, "plesset": 22, "partit": 22, "expans": [22, 83, 86, 88, 89], "fluctuat": 22, "close": [22, 33], "shell": [22, 33, 121, 157], "state": [22, 29, 30, 33, 46, 52, 59, 64, 65, 70, 72, 80, 97, 100, 101, 107, 122, 144, 145, 146, 148, 153], "correct": [22, 33], "taylor": 22, "unrestrict": [24, 122], "element": 25, "singl": [25, 31, 122], "mani": [25, 30, 31], "action": 25, "one": 25, "slater": [25, 29, 30, 31], "determin": [25, 29, 30, 31, 86, 87, 97, 99], "commut": 25, "spin": [25, 31, 86, 88, 97, 114, 122, 143], "adiabat": [25, 108], "born": 25, "oppenheim": 25, "expect": [25, 28, 88], "valu": [25, 28, 88], "combin": 26, "atom": [26, 38, 142, 150, 157], "assign": [26, 126], "librari": 26, "number": [26, 70], "addit": [26, 47], "rayleigh": 27, "schr\u00f6dinger": [27, 100], "rspt": 27, "master": 27, "extens": 27, "zeroth": 27, "second": [27, 29, 38, 49, 76], "reduc": [28, 66], "probabilist": [28, 30], "interpret": [28, 30], "quantiz": 29, "space": [29, 30, 106, 148], "creation": 29, "annihil": 29, "ground": [29, 46, 52, 59, 144, 145, 146], "f": 29, "4": 29, "10": 29, "term": [29, 47], "hilbert": 30, "vector": [30, 86, 142, 150], "pauli": 30, "principl": 30, "unitari": 30, "normal": [30, 156], "all": 31, "high": [31, 82, 89, 122], "homo": 31, "lumo": 31, "exercis": [33, 70, 92, 126, 131, 146], "sever": 33, "amplitud": 33, "t": [33, 42, 65], "o": 33, "h": 33, "dissoci": 33, "curv": 33, "unrelax": 33, "relax": [33, 143], "ozon": 33, "chromium": 33, "dimer": [33, 81], "chelpg": 34, "charg": [34, 36, 38, 41, 105], "embed": [35, 39, 40], "esp": 36, "loprop": 38, "polaris": 38, "t0": 38, "rearrang": 38, "t1": 38, "gram": 38, "schmidt": 38, "block": 38, "t2": 38, "l\u00f6dwin": 38, "orthonorm": 38, "occupi": 38, "virtual": 38, "t3": 38, "project": 38, "t4": 38, "orthogonalizatio": 38, "polariz": [38, 39, 40, 82, 83, 89, 113], "from": [38, 52, 106, 119, 133, 138, 144, 148], "respons": [38, 75, 76, 82, 86, 88, 89, 90, 91, 98, 99, 101, 109, 111], "ga": 39, "phase": [39, 97], "water": [39, 52], "liquid": 39, "solvat": [39, 147], "resp": 41, "instal": 42, "conda": 42, "faster": 42, "solver": 42, "For": 42, "window": 42, "user": [42, 100], "environ": 42, "file": [42, 157], "If": 42, "your": 42, "doesn": 42, "run": [42, 54, 81], "compil": 42, "echem": 42, "book": 42, "start": 43, "our": 43, "vision": 43, "who": 43, "we": 43, "ar": 43, "softwar": 43, "gator": 43, "multi": [43, 97, 122], "psi": 43, "other": 43, "tool": 43, "geometr": 43, "xtb": [43, 136, 139], "openmm": 43, "py3dmol": 43, "open": [43, 121], "babel": 43, "valet": 43, "conform": 44, "search": 44, "choic": [45, 55], "coordin": [45, 52, 58, 66], "cartesian": [45, 52, 66], "intern": [45, 52, 58, 66], "between": 45, "tdhf": 46, "tddft": [46, 124, 144, 147, 148], "forc": [47, 62, 66, 133, 136], "bond": [47, 120, 133], "stretch": 47, "anharmon": 47, "angl": [47, 62], "bend": 47, "torsion": 47, "van": 47, "der": 47, "waal": 47, "electrostat": 47, "hessian": [49, 50, 66, 86, 113, 131], "cphf": 49, "vibrat": [50, 66, 100, 129, 131, 156], "techniqu": 51, "dynam": [53, 120, 147, 155], "simul": 54, "ensembl": 55, "time": [55, 88, 91, 99, 104], "microcanon": 55, "nve": 55, "nvt": 55, "thermostat": 55, "isotherm": 55, "isobar": 55, "npt": 55, "barostat": 55, "euler": 55, "verlet": 55, "veloc": 55, "constrain": 58, "freez": 58, "scan": 58, "larger": [59, 147], "descent": 60, "conjug": 60, "newton": 60, "raphson": 60, "quasi": [60, 87, 112], "note": 60, "ir": [61, 130, 131], "intens": [61, 82, 113, 131], "raman": [61, 131, 132], "reparameter": 62, "dihedr": 62, "gaff": 62, "qm": 62, "weight": [62, 66], "exclud": 62, "tricki": 62, "transit": [64, 65, 81, 94, 100, 153], "irc": 65, "import": [65, 81], "modul": [65, 81], "find": 65, "driver": [65, 81], "frequenc": [65, 66], "free": 65, "compar": 65, "reactant": 65, "product": 65, "minim": 65, "go": 65, "forward": 65, "path": 65, "analysi": [66, 70, 113, 125, 131, 142, 153], "mass": 66, "translat": 66, "rotat": [66, 82, 97, 100], "frame": [66, 82], "displac": 66, "constant": 66, "algebra": 68, "diagrammat": 68, "core": [69, 106, 143, 147, 148], "valenc": [69, 106, 143, 144, 147, 148, 157], "adc": [70, 72, 124, 144, 145, 147], "summari": 70, "isr": 70, "0": 70, "1": 70, "step": [70, 144], "2": [70, 72, 147], "3": 70, "absorpt": [70, 81, 95, 117, 124, 144, 148], "spectrum": [70, 126, 132, 138, 142, 144, 151], "attach": [70, 153], "detach": [70, 153], "promot": 70, "hpc": [71, 119], "qc": 71, "intermedi": 72, "deriv": [72, 83], "via": 72, "explicit": 72, "express": 72, "comparison": [72, 106, 124, 139, 148], "relat": [72, 78], "individu": 72, "composit": 72, "polar": [73, 82, 125, 142], "propag": [73, 99], "birefring": 74, "dichroism": [74, 77], "circular": [74, 82], "axial": 74, "full": [75, 106, 134, 148], "cubic": 76, "hyperpolariz": [76, 83, 98], "pertin": [76, 98], "optic": [76, 98], "process": [76, 98], "isotrop": [76, 82, 89], "quantiti": 76, "equival": 78, "exciton": [80, 81], "coupl": [80, 143, 147, 148], "model": [80, 81, 128, 146], "subsystem": 80, "initi": [81, 139], "monom": 81, "print": [81, 125], "ecd": 81, "spectra": [81, 100, 124, 125, 142, 144, 158], "experi": [82, 151], "orient": 82, "laboratori": 82, "averag": [82, 101], "strength": 82, "spatial": 82, "formula": 82, "rank": 82, "five": 82, "tensor": [82, 91], "applic": 82, "quadrupolar": 82, "quadrat": [82, 98], "finit": 83, "differenti": 83, "multipol": 84, "quadrupol": 84, "baker": 86, "campbel": 86, "hausdorff": 86, "repres": 88, "monochromat": 88, "adapt": [86, 88], "transfer": [88, 105], "signific": 89, "anisotrop": 89, "compon": 89, "accuraci": [89, 149], "requir": 89, "cauchi": 89, "real": 89, "complex": [89, 113, 133], "concept": 90, "dioxetan": 92, "chemiluminesc": 92, "uv": [95, 123], "vi": [95, 123], "parameter": 97, "isol": 97, "level": 99, "pole": 99, "rovibron": 100, "numerov": 100, "": 100, "rovibr": 100, "vibron": 100, "casci": 101, "specif": 101, "select": [102, 128, 149], "rule": 102, "cv": [106, 143, 144, 145, 147, 148], "foundat": 108, "rung": 108, "gross": 108, "rpa": 113, "eigenst": [113, 125, 148], "flip": 114, "tamm": [115, 146], "dancoff": [115, 146], "triplet": 116, "instabl": 116, "photon": 117, "center": 119, "b": 119, "comput": 119, "chemistri": 119, "laptop": 119, "versu": [120, 122, 149], "break": 120, "At": 120, "equilibrium": 120, "distanc": 120, "low": 122, "broken": 122, "solut": [122, 142, 146], "spectroscopi": [123, 129, 130, 132, 141, 144, 148], "cpp": [124, 144, 145], "domin": 125, "cost": [126, 147], "save": [126, 147], "fluoresc": 127, "recommend": [128, 149], "geometri": [131, 136, 156], "build": 133, "smile": 133, "branch": 133, "substitut": 133, "ring": 133, "more": 133, "download": 133, "pdb": 133, "databank": 133, "assembl": 134, "workflow": [134, 140, 145], "global": 135, "warm": 135, "methan": 136, "combust": 136, "reaction": 136, "specifi": 137, "k": 137, "x": [141, 144, 147, 148], "rai": [141, 144, 148], "look": 142, "decomposit": 142, "special": 143, "ioniz": [143, 148], "de": 143, "includ": 143, "deltascf": [143, 144], "base": 143, "rel": 143, "scalar": 143, "relativist": [143, 149], "consider": 143, "hole": 143, "tailor": 143, "post": 143, "aufbau": 143, "spuriou": 143, "mix": 143, "xa": [143, 145, 146, 147, 148], "photoemiss": 144, "maximum": 144, "delta": [144, 145], "textrm": 144, "decoupl": 144, "continuum": 144, "casscf": 144, "emiss": 144, "reson": 144, "inelast": 144, "scatter": 144, "approach": 144, "cheat": 145, "sheet": 145, "typic": 145, "xp": 145, "xe": [145, 147, 148], "chemic": 146, "shift": 146, "augment": 146, "uracil": 147, "phthalocyanin": 147, "transient": 148, "impact": 148, "channel": 148, "consid": 148, "revers": 148, "precis": 149, "stuctur": 149, "unit": 150, "notat": 150, "convers": 150, "indic": 150, "common": 150, "short": 150, "hand": 150, "broaden": 151, "lorentzian": 151, "gaussian": 151, "voigt": 151, "md": 154, "trajectori": 154, "mode": 156, "orbitalview": 157, "cube": 157, "radial": 157, "distribut": 157, "sub": 157, "setup": 86}, "envversion": {"sphinx.domains.c": 3, "sphinx.domains.changeset": 1, "sphinx.domains.citation": 1, "sphinx.domains.cpp": 9, "sphinx.domains.index": 1, "sphinx.domains.javascript": 3, "sphinx.domains.math": 2, "sphinx.domains.python": 4, "sphinx.domains.rst": 2, "sphinx.domains.std": 2, "sphinx.ext.intersphinx": 1, "sphinxcontrib.bibtex": 9, "sphinx": 60}, "alltitles": {"Using Jupyter notebooks": [[0, "using-jupyter-notebooks"]], "Cell types": [[0, "cell-types"]], "Markdown cells": [[0, "markdown-cells"]], "Code cells": [[0, "code-cells"]], "Python ecosystem": [[0, "python-ecosystem"]], "Molecular structure": [[0, "molecular-structure"], [159, "molecular-structure"]], "Visualize": [[0, "visualize"]], "Electronic structure": [[0, "electronic-structure"], [152, "electronic-structure"]], "Perform SCF calculations": [[0, "perform-scf-calculations"]], "Visualize molecular orbitals": [[0, "visualize-molecular-orbitals"]], "Basis set effects": [[0, "basis-set-effects"]], "Python lists": [[0, "python-lists"]], "Plotting results": [[0, "plotting-results"]], "Potential energy surfaces": [[0, "potential-energy-surfaces"]], "Constructing a PES": [[0, "constructing-a-pes"]], "Interpolation with spline": [[0, "interpolation-with-spline"]], "Fit harmonic function": [[0, "fit-harmonic-function"]], "Functions and examples": [[0, "functions-and-examples"]], "Einstein summation": [[0, "einstein-summation"]], "AO to MO transformation": [[0, "ao-to-mo-transformation"], [17, "ao-to-mo-transformation"]], "Eigenvalues and eigenvectors": [[0, "eigenvalues-and-eigenvectors"]], "Dictionaries": [[0, "dictionaries"]], "Function isinstance": [[0, "function-isinstance"]], "Functions np.zeros and np.ones": [[0, "functions-np-zeros-and-np-ones"]], "Functions np.rad2deg and np.deg2rad": [[0, "functions-np-rad2deg-and-np-deg2rad"]], "External websites and tutorials": [[0, "external-websites-and-tutorials"]], "How to cite and contact": [[1, "how-to-cite-and-contact"]], "Available XC functionals": [[2, "available-xc-functionals"]], "Hartree\u2013Fock": [[2, "hartreefock"], [12, "hartree-fock"], [85, "hartreefock"]], "MP2": [[2, "mp2"], [33, "mp2"], [46, "mp2"]], "FCI": [[2, "fci"]], "DFT": [[2, "dft"], [46, "dft"], [49, "dft"]], "Plotting the energies": [[2, "plotting-the-energies"]], "Configuration interaction": [[3, "configuration-interaction"], [33, "configuration-interaction"], [75, "configuration-interaction"]], "General theory": [[3, "general-theory"]], "The N-electron basis": [[3, "the-n-electron-basis"]], "The CI Hamiltonian": [[3, "the-ci-hamiltonian"]], "Direct CI": [[3, "direct-ci"]], "Density matrices and natural orbitals": [[3, "density-matrices-and-natural-orbitals"]], "Truncated CI": [[3, "truncated-ci"], [75, "truncated-ci"]], "Restricting the excitations": [[3, "restricting-the-excitations"]], "Size consistency": [[3, "size-consistency"], [22, "size-consistency"], [72, "size-consistency"]], "Electron correlation": [[4, "electron-correlation"], [89, "electron-correlation"]], "Correlation energy": [[4, "correlation-energy"]], "Visualizing electron correlation": [[4, "visualizing-electron-correlation"]], "One-particle density": [[4, "one-particle-density"], [28, "one-particle-density"], [29, "one-particle-density"]], "Two-particle density": [[4, "two-particle-density"], [28, "two-particle-density"]], "Electron cusp and basis set convergence": [[4, "electron-cusp-and-basis-set-convergence"]], "Density functional theory": [[5, "density-functional-theory"]], "First-order properties": [[6, "first-order-properties"], [46, "first-order-properties"], [84, "first-order-properties"]], "Numerical integration": [[6, "numerical-integration"]], "Analytic integration": [[6, "analytic-integration"]], "SCF optimization": [[7, "scf-optimization"], [13, "scf-optimization"], [14, "scf-optimization"], [137, "scf-optimization"]], "Setting up the system": [[7, "setting-up-the-system"]], "Reference calculation": [[7, "reference-calculation"], [10, "reference-calculation"], [14, "reference-calculation"], [39, "reference-calculation"], [94, "reference-calculation"], [115, "reference-calculation"]], "XC contribution to Fock matrix": [[7, "xc-contribution-to-fock-matrix"]], "SCF procedure": [[7, "scf-procedure"], [15, "scf-procedure"]], "Self-interaction error": [[7, "self-interaction-error"]], "Dispersion interactions": [[8, "dispersion-interactions"]], "Long-range interaction energy": [[8, "long-range-interaction-energy"]], "Dispersion and correlation": [[8, "dispersion-and-correlation"]], "Dispersion by perturbation theory": [[8, "dispersion-by-perturbation-theory"]], "General aspects": [[9, "general-aspects"], [56, "general-aspects"], [103, "general-aspects"]], "Fock matrix diagonalization": [[10, "fock-matrix-diagonalization"]], "Hartree\u2013Fock equation": [[10, "hartreefock-equation"], [15, "hartreefock-equation"]], "Solving a generalized eigenvalue problem": [[10, "solving-a-generalized-eigenvalue-problem"]], "Standard case": [[10, "standard-case"]], "Non-standard case": [[10, "non-standard-case"]], "Linear dependence in basis set": [[10, "linear-dependence-in-basis-set"]], "Diagonalizing the overlap matrix": [[10, "diagonalizing-the-overlap-matrix"]], "Orthogonalizing the AO basis": [[10, "orthogonalizing-the-ao-basis"]], "Symmetry": [[11, "symmetry"]], "Active or passive point of view": [[11, "active-or-passive-point-of-view"]], "Invariance of observables": [[11, "invariance-of-observables"]], "Symmetry operations": [[11, "symmetry-operations"]], "Point groups": [[11, "point-groups"]], "Character tables": [[11, "character-tables"]], "C_\\mathsf{2v}": [[11, "c-mathsf-2v"]], "C_\\mathsf{2h}": [[11, "c-mathsf-2h"]], "D_\\mathsf{2h}": [[11, "d-mathsf-2h"]], "Wave function symmetry": [[11, "wave-function-symmetry"]], "HF in VeloxChem": [[13, "hf-in-veloxchem"]], "Define the molecule": [[13, "define-the-molecule"]], "SCF information": [[13, "scf-information"]], "Visualizing molecular orbitals": [[13, "visualizing-molecular-orbitals"], [125, "visualizing-molecular-orbitals"], [137, "visualizing-molecular-orbitals"]], "SCF energy": [[14, "scf-energy"]], "Some system parameters": [[14, "some-system-parameters"]], "Getting integrals in AO basis": [[14, "getting-integrals-in-ao-basis"]], "Convergence measure": [[14, "convergence-measure"]], "SCF iterations": [[14, "scf-iterations"], [14, "id2"]], "Convergence acceleration": [[14, "convergence-acceleration"]], "Direct inversion iterative subspace": [[14, "direct-inversion-iterative-subspace"]], "Hartree\u2013Fock theory": [[15, "hartreefock-theory"]], "Lagrangian": [[15, "lagrangian"]], "Canonical form": [[15, "canonical-form"]], "In AO basis": [[15, "in-ao-basis"]], "Hartree\u2013Fock energy": [[15, "hartreefock-energy"]], "Koopmans theorem": [[15, "koopmans-theorem"]], "Brillouin theorem": [[15, "brillouin-theorem"]], "Roothaan\u2013Hall scheme": [[15, "roothaanhall-scheme"]], "Hohenberg\u2013Kohn theorems": [[16, "hohenbergkohn-theorems"]], "HK theorem I": [[16, "hk-theorem-i"]], "HK theorem II": [[16, "hk-theorem-ii"]], "N-representability": [[16, "n-representability"]], "Integrals": [[17, "integrals"]], "Ordering": [[17, "ordering"]], "Exposure to Python layer": [[17, "exposure-to-python-layer"]], "Overlap": [[17, "overlap"]], "Kinetic energy": [[17, "kinetic-energy"]], "Nuclear potential": [[17, "nuclear-potential"]], "One-electron Hamiltonian": [[17, "one-electron-hamiltonian"]], "Linear momentum": [[17, "linear-momentum"]], "Electric dipole moment": [[17, "electric-dipole-moment"]], "Magnetic dipole moment": [[17, "magnetic-dipole-moment"]], "Electron repulsion integrals": [[17, "electron-repulsion-integrals"]], "Integral transformations": [[17, "integral-transformations"]], "One-electron integrals": [[17, "one-electron-integrals"]], "MO to AO transformation": [[17, "mo-to-ao-transformation"]], "Two-electron integrals": [[17, "two-electron-integrals"], [150, "two-electron-integrals"]], "Conventional": [[17, "conventional"]], "Fock-matrix driven": [[17, "fock-matrix-driven"]], "Kernel integration": [[18, "kernel-integration"]], "Molecular grid points": [[18, "molecular-grid-points"]], "Density on grid points": [[18, "density-on-grid-points"]], "Kohn\u2013Sham method": [[19, "kohnsham-method"]], "Kohn\u2013Sham equation": [[19, "kohnsham-equation"]], "Exchange\u2013correlation functionals": [[19, "exchangecorrelation-functionals"]], "Local density approximation (LDA)": [[19, "local-density-approximation-lda"]], "Generalized gradient approximation (GGA)": [[19, "generalized-gradient-approximation-gga"]], "Meta generalized gradient approximation (mGGA)": [[19, "meta-generalized-gradient-approximation-mgga"]], "Hybrid exchange-correlation functionals": [[19, "hybrid-exchange-correlation-functionals"]], "Range separated exchange-correlation functionals": [[19, "range-separated-exchange-correlation-functionals"]], "Known deficiencies": [[19, "known-deficiencies"]], "MC-PDFT": [[20, "mc-pdft"]], "DFT for strong correlation": [[20, "dft-for-strong-correlation"]], "Pair-density functional theory": [[20, "pair-density-functional-theory"]], "Multiconfigurational pair-density functional theory": [[20, "multiconfigurational-pair-density-functional-theory"]], "MCSCF": [[21, "mcscf"], [33, "mcscf"], [124, "mcscf"]], "Strong/static correlation": [[21, "strong-static-correlation"]], "The Multiconfigurational Self-Consistent Field method (MCSCF)": [[21, "the-multiconfigurational-self-consistent-field-method-mcscf"]], "Illustrative example": [[21, "illustrative-example"]], "Theory": [[21, "theory"], [111, "theory"]], "Implementation": [[21, "implementation"], [60, "implementation"], [60, "id2"], [60, "id3"], [81, "implementation"], [94, "implementation"], [110, "implementation"]], "Multireference correlation": [[21, "multireference-correlation"]], "M\u00f8ller\u2013Plesset": [[22, "mollerplesset"]], "M\u00f8ller\u2013Plesset partitioning": [[22, "mollerplesset-partitioning"]], "Perturbation expansion in the fluctuation potential": [[22, "perturbation-expansion-in-the-fluctuation-potential"]], "Closed-shell reference state": [[22, "closed-shell-reference-state"]], "Illustration": [[22, "illustration"], [28, "illustration"], [28, "id3"], [88, "illustration"], [86, "illustration"]], "Hartree\u2013Fock reference state": [[22, "hartreefock-reference-state"]], "Integrals in the MO basis": [[22, "integrals-in-the-mo-basis"]], "The MP2 energy correction": [[22, "the-mp2-energy-correction"]], "Taylor expansion of the energy": [[22, "taylor-expansion-of-the-energy"]], "Multireference methods": [[23, "multireference-methods"], [93, "multireference-methods"]], "Natural orbitals": [[24, "natural-orbitals"]], "Restricted orbitals": [[24, "restricted-orbitals"]], "Unrestricted orbitals": [[24, "unrestricted-orbitals"]], "Operators and matrix elements": [[25, "operators-and-matrix-elements"]], "Single-electron systems": [[25, "single-electron-systems"], [31, "single-electron-systems"]], "Many-electron systems": [[25, "many-electron-systems"], [31, "many-electron-systems"]], "One-electron operators": [[25, "one-electron-operators"], [29, "one-electron-operators"]], "Action of one-electron operators on Slater determinants": [[25, "action-of-one-electron-operators-on-slater-determinants"]], "Commutator of one-electron operators": [[25, "commutator-of-one-electron-operators"]], "Two-electron operators": [[25, "two-electron-operators"], [29, "two-electron-operators"]], "Matrix elements for Slater determinants": [[25, "matrix-elements-for-slater-determinants"]], "Spin orbitals": [[25, "spin-orbitals"]], "Molecular orbitals": [[25, "molecular-orbitals"], [157, "molecular-orbitals"]], "Molecular Hamiltonian": [[25, "molecular-hamiltonian"]], "Adiabatic Born\u2013Oppenheimer approximation": [[25, "adiabatic-bornoppenheimer-approximation"]], "Matrix element of electronic Hamiltonian": [[25, "matrix-element-of-electronic-hamiltonian"]], "Expectation value of one-electron Hamiltonian": [[25, "expectation-value-of-one-electron-hamiltonian"]], "Expectation value of two-electron Hamiltonian": [[25, "expectation-value-of-two-electron-hamiltonian"]], "Expectation value of electronic Hamiltonian": [[25, "expectation-value-of-electronic-hamiltonian"]], "Orbitals and basis sets": [[26, "orbitals-and-basis-sets"]], "Electronic wave functions and molecular orbitals": [[26, "electronic-wave-functions-and-molecular-orbitals"]], "Linear combination of atomic orbitals": [[26, "linear-combination-of-atomic-orbitals"]], "Ordering of atomic orbitals": [[26, "ordering-of-atomic-orbitals"]], "Overlap matrix": [[26, "overlap-matrix"], [113, "overlap-matrix"]], "Basis sets of atomic orbitals": [[26, "basis-sets-of-atomic-orbitals"]], "Assign to molecule": [[26, "assign-to-molecule"]], "Basis set library": [[26, "basis-set-library"]], "Number of basis functions": [[26, "number-of-basis-functions"]], "Additional information": [[26, "additional-information"]], "Rayleigh\u2013Schr\u00f6dinger perturbation theory": [[27, "rayleighschrodinger-perturbation-theory"]], "Solving the RSPT master equation": [[27, "solving-the-rspt-master-equation"]], "Numerical illustration": [[27, "numerical-illustration"]], "Size extensivity in RSPT": [[27, "size-extensivity-in-rspt"]], "Zeroth- and first-order energies": [[27, "zeroth-and-first-order-energies"]], "Second-order energy": [[27, "second-order-energy"]], "Reduced particle densities": [[28, "reduced-particle-densities"]], "Probabilistic interpretation": [[28, "probabilistic-interpretation"], [28, "id1"], [30, "probabilistic-interpretation"]], "Expectation values": [[28, "expectation-values"], [28, "id2"]], "One-particle density operator": [[28, "one-particle-density-operator"]], "Two-particle density operator": [[28, "two-particle-density-operator"]], "Second quantization": [[29, "second-quantization"]], "Fock space": [[29, "fock-space"]], "Creation and annihilation operators": [[29, "creation-and-annihilation-operators"]], "Ground state": [[29, "ground-state"], [46, "ground-state"], [59, "ground-state"]], "Slater determinants": [[29, "slater-determinants"], [30, "slater-determinants"]], "Illustration for Fock space F(4,10)": [[29, "illustration-for-fock-space-f-4-10"]], "Hamiltonian": [[29, "hamiltonian"]], "Energy": [[29, "energy"]], "One-electron term": [[29, "one-electron-term"]], "Two-electron term": [[29, "two-electron-term"]], "Many-electron wave functions": [[30, "many-electron-wave-functions"]], "Hilbert space of state vectors": [[30, "hilbert-space-of-state-vectors"]], "Pauli principle": [[30, "pauli-principle"]], "Unitary orbital transformations": [[30, "unitary-orbital-transformations"]], "Normalization": [[30, "normalization"]], "N-particle density": [[30, "n-particle-density"]], "Electron spin": [[31, "electron-spin"]], "Spin and Slater determinants": [[31, "spin-and-slater-determinants"]], "All determinants": [[31, "all-determinants"]], "High-spin determinants": [[31, "high-spin-determinants"]], "HOMO\u2013LUMO excited determinants": [[31, "homolumo-excited-determinants"]], "Wave function theory": [[32, "wave-function-theory"]], "Exercises": [[33, "exercises"], [70, "exercises"], [92, "exercises"], [126, "exercises"], [131, "exercises"], [146, "exercises"]], "Hartree-Fock": [[33, "hartree-fock"]], "One-particle density matrix": [[33, "one-particle-density-matrix"]], "Several states": [[33, "several-states"]], "Calculate the closed-shell MP2 energy correction": [[33, "calculate-the-closed-shell-mp2-energy-correction"]], "Calculate the MP2 amplitudes": [[33, "calculate-the-mp2-amplitudes"]], "Calculate the MP2 energy correction using the t amplitudes": [[33, "calculate-the-mp2-energy-correction-using-the-t-amplitudes"]], "O\u2013H dissociation potential energy curve": [[33, "o-h-dissociation-potential-energy-curve"]], "Dipole moment": [[33, "dipole-moment"], [39, "dipole-moment"]], "HF dipole moment": [[33, "hf-dipole-moment"]], "Unrelaxed MP2 dipole moment": [[33, "unrelaxed-mp2-dipole-moment"]], "Approximate relaxed MP2 dipole moment": [[33, "approximate-relaxed-mp2-dipole-moment"]], "Numerical HF and MP2 dipole moment": [[33, "numerical-hf-and-mp2-dipole-moment"]], "Ozone": [[33, "ozone"]], "Chromium dimer": [[33, "chromium-dimer"]], "CHELPG charges": [[34, "chelpg-charges"]], "Embedding potentials": [[35, "embedding-potentials"]], "ESP charges": [[36, "esp-charges"]], "Localized properties": [[37, "localized-properties"]], "LoProp charges and polarisabilities": [[38, "loprop-charges-and-polarisabilities"]], "Reference LoProp calculations": [[38, "reference-loprop-calculations"]], "LoProp transformation": [[38, "loprop-transformation"]], "T0: Atomic orbital rearrangement": [[38, "t0-atomic-orbital-rearrangement"]], "T1: Gram\u2013Schmidt orthogonalization of atomic blocks": [[38, "t1-gramschmidt-orthogonalization-of-atomic-blocks"]], "T2: L\u00f6dwin orthonormalization of occupied and virtual blocks": [[38, "t2-lodwin-orthonormalization-of-occupied-and-virtual-blocks"]], "T3: Occupied\u2013virtual projection": [[38, "t3-occupiedvirtual-projection"]], "T4: L\u00f6dwin orthogonalizatio of virtual blocks": [[38, "t4-lodwin-orthogonalizatio-of-virtual-blocks"]], "Localization of first-order properties": [[38, "localization-of-first-order-properties"]], "Localized charges": [[38, "localized-charges"]], "Localized dipole moments": [[38, "localized-dipole-moments"]], "Localization of second-order properties": [[38, "localization-of-second-order-properties"]], "Polarizabilities from response functions": [[38, "polarizabilities-from-response-functions"]], "Polarizabilities from perturbed density matrices": [[38, "polarizabilities-from-perturbed-density-matrices"]], "Localized polarizabilities": [[38, "localized-polarizabilities"]], "Non-polarizable embedding": [[39, "non-polarizable-embedding"]], "Gas phase water": [[39, "gas-phase-water"]], "SCF calculation": [[39, "scf-calculation"]], "Liquid water": [[39, "liquid-water"]], "Embedding operator": [[39, "embedding-operator"]], "Solvation energies": [[39, "solvation-energies"]], "Dipole moments": [[39, "dipole-moments"]], "Polarizable embedding": [[40, "polarizable-embedding"]], "RESP charges": [[41, "resp-charges"]], "Installation": [[42, "installation"]], "Conda installation": [[42, "conda-installation"]], "Faster conda solver": [[42, null]], "For Windows users": [[42, "for-windows-users"]], "Environment file": [[42, "environment-file"]], "If your notebook doesn\u2019t run": [[42, "if-your-notebook-doesn-t-run"]], "Compiling a local eChem book": [[42, "compiling-a-local-echem-book"]], "Getting started": [[43, "getting-started"]], "Our vision": [[43, "our-vision"]], "Who we are": [[43, "who-we-are"]], "Our software": [[43, "our-software"]], "VeloxChem": [[43, "veloxchem"]], "Gator": [[43, "gator"]], "Multi-Psi": [[43, "multi-psi"]], "Other tools": [[43, "other-tools"]], "geomeTRIC": [[43, "geometric"]], "xTB": [[43, "xtb"]], "OpenMM": [[43, "openmm"]], "py3Dmol": [[43, "py3dmol"]], "Open Babel": [[43, "open-babel"]], "Valet": [[43, "valet"]], "Conformer search": [[44, "conformer-search"]], "Conformer optimization": [[44, "conformer-optimization"]], "Choice of coordinates": [[45, "choice-of-coordinates"]], "Cartesian coordinates": [[45, "cartesian-coordinates"]], "Internal coordinates": [[45, "internal-coordinates"]], "Transforming between coordinate systems": [[45, "transforming-between-coordinate-systems"]], "Energy gradients": [[46, "energy-gradients"]], "Numerical Gradients": [[46, "numerical-gradients"]], "Analytical Gradients": [[46, "analytical-gradients"]], "HF": [[46, "hf"], [49, "hf"]], "Excited states": [[46, "excited-states"], [107, "excited-states"], [153, "excited-states"]], "CIS": [[46, "cis"]], "TDHF": [[46, "tdhf"]], "TDDFT": [[46, "tddft"], [124, "tddft"]], "Force fields": [[47, "force-fields"]], "Bonded terms": [[47, "bonded-terms"]], "Bond stretching": [[47, "bond-stretching"]], "Harmonic fit": [[47, "harmonic-fit"], [47, "id1"]], "Anharmonic fit": [[47, "anharmonic-fit"]], "Angle bending": [[47, "angle-bending"]], "Torsion": [[47, "torsion"]], "Non-bonded terms": [[47, "non-bonded-terms"]], "van der Waals interactions": [[47, "van-der-waals-interactions"]], "Electrostatic interaction": [[47, "electrostatic-interaction"]], "van der Waals interaction": [[47, "van-der-waals-interaction"]], "Additional terms": [[47, "additional-terms"]], "Gradients": [[48, "gradients"]], "Molecular Hessians": [[49, "molecular-hessians"]], "Numerical Hessians": [[49, "numerical-hessians"]], "Analytical Hessians": [[49, "analytical-hessians"]], "CPHF equations": [[49, "cphf-equations"]], "Perturbed density": [[49, "perturbed-density"]], "Second-order properties": [[49, "second-order-properties"]], "Hessians and vibrations": [[50, "hessians-and-vibrations"]], "PES interpolation techniques": [[51, "pes-interpolation-techniques"]], "Constructing the PES by interpolation": [[52, "constructing-the-pes-by-interpolation"]], "The ground state potential energy surface of water": [[52, "the-ground-state-potential-energy-surface-of-water"]], "Transforming from Cartesian to internal coordinates": [[52, "transforming-from-cartesian-to-internal-coordinates"]], "Ground-state PES by interpolation": [[52, "ground-state-pes-by-interpolation"]], "Molecular dynamics": [[53, "molecular-dynamics"]], "Running a simulation": [[54, "running-a-simulation"]], "Ensembles and time integration": [[55, "ensembles-and-time-integration"]], "Choice of ensemble": [[55, "choice-of-ensemble"]], "Microcanonical ensemble (NVE)": [[55, "microcanonical-ensemble-nve"]], "Canonical ensemble (NVT)": [[55, "canonical-ensemble-nvt"]], "Thermostat": [[55, "thermostat"]], "Isothermal-isobaric ensemble (NPT)": [[55, "isothermal-isobaric-ensemble-npt"]], "Barostat": [[55, "barostat"]], "Time integration": [[55, "time-integration"]], "Euler integration": [[55, "euler-integration"]], "Verlet integration": [[55, "verlet-integration"]], "Velocity Verlet": [[55, "velocity-verlet"]], "Structure optimization": [[57, "structure-optimization"]], "Constrained coordinates": [[58, "constrained-coordinates"]], "Set and freeze internal coordinates": [[58, "set-and-freeze-internal-coordinates"]], "Scan internal coordinates": [[58, "scan-internal-coordinates"]], "Larger molecules": [[59, "larger-molecules"]], "Optimization methods": [[60, "optimization-methods"]], "Gradient descent": [[60, "gradient-descent"]], "Conjugate gradient": [[60, "conjugate-gradient"]], "Newton\u2013Raphson": [[60, "newton-raphson"]], "Quasi-Newton": [[60, "quasi-newton"]], "Note": [[60, null]], "Property gradients": [[61, "property-gradients"]], "IR intensities": [[61, "ir-intensities"]], "Raman intensities": [[61, "raman-intensities"]], "Reparameterize force fields": [[62, "reparameterize-force-fields"]], "Dihedral angles": [[62, "dihedral-angles"]], "GAFF force field": [[62, "gaff-force-field"]], "Fitting to QM potential": [[62, "fitting-to-qm-potential"]], "Weighted fitting": [[62, "weighted-fitting"]], "Excluding tricky angles": [[62, "excluding-tricky-angles"]], "Molecular symmetry": [[63, "molecular-symmetry"]], "Transition-state theory": [[64, "transition-state-theory"]], "Transition state": [[65, "transition-state"]], "IRC method": [[65, "irc-method"]], "Importing modules": [[65, "importing-modules"]], "Visualization of the molecule": [[65, "visualization-of-the-molecule"]], "Finding the Transition State": [[65, "finding-the-transition-state"]], "Setting up the SCF driver": [[65, "setting-up-the-scf-driver"]], "Setting up the gradient driver": [[65, "setting-up-the-gradient-driver"]], "Setting up the optimization driver": [[65, "setting-up-the-optimization-driver"]], "Visualization of the TS frequencies": [[65, "visualization-of-the-ts-frequencies"]], "Calculation of the activation free energy": [[65, "calculation-of-the-activation-free-energy"]], "Comparing reactant and transition state": [[65, "comparing-reactant-and-transition-state"]], "Finding the product": [[65, "finding-the-product"]], "Minimizing the structure to product: going forward the IRC path": [[65, "minimizing-the-structure-to-product-going-forward-the-irc-path"]], "Vibrational analysis": [[66, "vibrational-analysis"], [131, "vibrational-analysis"]], "Cartesian and mass-weighted Hessian": [[66, "cartesian-and-mass-weighted-hessian"]], "Translating and rotating frame": [[66, "translating-and-rotating-frame"]], "Hessian in internal coordinates and harmonic frequencies": [[66, "hessian-in-internal-coordinates-and-harmonic-frequencies"]], "Cartesian displacements, reduced masses, and force constants": [[66, "cartesian-displacements-reduced-masses-and-force-constants"]], "References": [[67, "references"]], "Algebraic-diagrammatic construction": [[68, "algebraic-diagrammatic-construction"]], "Core-valence separation": [[69, "core-valence-separation"], [106, "core-valence-separation"]], "ADC summary": [[70, "adc-summary"]], "ISR for ADC(0) and ADC(1)": [[70, "isr-for-adc-0-and-adc-1"]], "Step 1. Calculate the reference state": [[70, "step-1-calculate-the-reference-state"]], "Step 2. Construct the ADC(0) and ADC(1) matrices": [[70, "step-2-construct-the-adc-0-and-adc-1-matrices"]], "Step 3. Diagonalize the ADC matrix": [[70, "step-3-diagonalize-the-adc-matrix"]], "The absorption spectrum": [[70, "the-absorption-spectrum"]], "Excited state analysis": [[70, "excited-state-analysis"]], "Attachment and detachment densities": [[70, "attachment-and-detachment-densities"], [153, "attachment-and-detachment-densities"]], "Promotion numbers": [[70, "promotion-numbers"]], "HPC-QC implementation": [[71, "hpc-qc-implementation"]], "Intermediate state representation": [[72, "intermediate-state-representation"]], "Derivation via intermediate states": [[72, "derivation-via-intermediate-states"]], "Structure of the ADC matrix": [[72, "structure-of-the-adc-matrix"]], "Explicit expressions for ADC(2)": [[72, "explicit-expressions-for-adc-2"]], "Comparison to related methods": [[72, "comparison-to-related-methods"]], "Excited-state properties": [[72, "excited-state-properties"]], "Calculate HF reference states": [[72, "calculate-hf-reference-states"]], "Excitation energies of individual systems": [[72, "excitation-energies-of-individual-systems"]], "Composite system": [[72, "composite-system"]], "Polarization propagator": [[73, "polarization-propagator"]], "Birefringences and dichroisms": [[74, "birefringences-and-dichroisms"]], "Linear birefringence": [[74, "linear-birefringence"]], "Circular birefringence": [[74, "circular-birefringence"]], "Axial birefringence": [[74, "axial-birefringence"]], "Full-CI response": [[75, "full-ci-response"]], "Cubic response": [[76, "cubic-response"]], "Second-order electric-dipole hyperpolarizability": [[76, "second-order-electric-dipole-hyperpolarizability"]], "Pertinent optical processes": [[76, "pertinent-optical-processes"], [98, "pertinent-optical-processes"]], "Isotropic quantities": [[76, "isotropic-quantities"]], "Dispersion": [[76, "dispersion"], [98, "dispersion"], [99, "dispersion"]], "In VeloxChem": [[76, "in-veloxchem"], [89, "in-veloxchem"], [98, "in-veloxchem"]], "Dichroism": [[77, "dichroism"]], "Dipole equivalence relations": [[78, "dipole-equivalence-relations"]], "Electronic and nuclear contributions": [[79, "electronic-and-nuclear-contributions"]], "Exciton coupling model": [[80, "exciton-coupling-model"]], "Subsystems and states": [[80, "subsystems-and-states"]], "Energies and couplings": [[80, "energies-and-couplings"]], "Example": [[81, "example"]], "Import modules": [[81, "import-modules"]], "Set up molecule and basis set": [[81, "set-up-molecule-and-basis-set"]], "Set up the exciton model driver": [[81, "set-up-the-exciton-model-driver"]], "Initializes exciton model Hamiltonian and transition dipoles": [[81, "initializes-exciton-model-hamiltonian-and-transition-dipoles"]], "Run monomer calculations": [[81, "run-monomer-calculations"]], "Run dimer calculations": [[81, "run-dimer-calculations"]], "Print the exciton model Hamiltonian": [[81, "print-the-exciton-model-hamiltonian"]], "Get excitation energies and transition dipoles": [[81, "get-excitation-energies-and-transition-dipoles"]], "Plot absorption and ECD spectra": [[81, "plot-absorption-and-ecd-spectra"]], "Experiment to theory": [[82, "experiment-to-theory"]], "Isotropic molecular orientation": [[82, "isotropic-molecular-orientation"]], "Laboratory and molecular frames": [[82, "laboratory-and-molecular-frames"]], "Rotational averages": [[82, "rotational-averages"]], "Fields and polarization": [[82, "fields-and-polarization"]], "Linear polarization": [[82, "linear-polarization"]], "Circular polarization": [[82, "circular-polarization"]], "Field strengths and intensities": [[82, "field-strengths-and-intensities"]], "Spatial averaging of high order properties": [[82, "spatial-averaging-of-high-order-properties"]], "Formulae for rank two to rank five tensor properties": [[82, "formulae-for-rank-two-to-rank-five-tensor-properties"]], "Example of application: electric dipole polarizability": [[82, "example-of-application-electric-dipole-polarizability"]], "Example of application: quadrupolar contributions": [[82, "example-of-application-quadrupolar-contributions"]], "Linear response": [[82, "linear-response"], [90, "linear-response"], [109, "linear-response"]], "Quadratic response": [[82, "quadratic-response"], [98, "quadratic-response"]], "Finite field method": [[83, "finite-field-method"]], "Energy expansion": [[83, "energy-expansion"]], "Dipole moment expansion": [[83, "dipole-moment-expansion"]], "Polarizability expansion": [[83, "polarizability-expansion"]], "Hyperpolarizability expansion": [[83, "hyperpolarizability-expansion"]], "Numerical example": [[83, "numerical-example"]], "Numerical differentiation": [[83, "numerical-differentiation"]], "Field-dependent molecular properties": [[83, "field-dependent-molecular-properties"]], "Calculate derivatives": [[83, "calculate-derivatives"]], "Results": [[83, "results"]], "Electric multipole moments": [[84, "electric-multipole-moments"]], "Dipole and quadrupole moments": [[84, "dipole-and-quadrupole-moments"]], "Quasi-energy determination of parameters": [[87, "quasi-energy-determination-of-parameters"]], "Linear Response": [[89, "linear-response"]], "Electric-dipole polarizability": [[89, "electric-dipole-polarizability"], [113, "electric-dipole-polarizability"]], "Significance": [[89, "significance"]], "Isotropic and anisotropic components": [[89, "isotropic-and-anisotropic-components"]], "Measurements": [[89, "measurements"]], "High-accuracy results": [[89, "high-accuracy-results"]], "Basis set requirements": [[89, "basis-set-requirements"]], "Cauchy moment expansion": [[89, "cauchy-moment-expansion"]], "Real response function": [[89, "real-response-function"]], "Complex response function": [[89, "complex-response-function"]], "Concept": [[90, "concept"]], "Illustrative calculations": [[90, "illustrative-calculations"]], "Molecular properties": [[91, "molecular-properties"]], "Static fields": [[91, "static-fields"]], "Time-dependent fields": [[91, "time-dependent-fields"]], "Response theory": [[91, "response-theory"], [111, "response-theory"]], "Tensor properties": [[91, "tensor-properties"]], "Electric properties": [[91, "electric-properties"]], "Dioxetane chemiluminescence": [[92, "dioxetane-chemiluminescence"]], "Natural transition orbitals": [[94, "natural-transition-orbitals"], [153, "natural-transition-orbitals"]], "Visualization": [[94, "visualization"], [136, "visualization"]], "UV/vis absorption": [[95, "uv-vis-absorption"]], "Field-dependence of parameters": [[96, "field-dependence-of-parameters"]], "Orbital rotations": [[97, "orbital-rotations"]], "Reference state parameterization": [[97, "reference-state-parameterization"]], "Generator of orbital rotations": [[97, "generator-of-orbital-rotations"]], "Phase isolation": [[97, "phase-isolation"], [97, "id1"]], "Spin symmetry": [[97, "spin-symmetry"], [97, "id2"]], "Illustrations": [[97, "illustrations"]], "Multi-electron excited determinants": [[97, "multi-electron-excited-determinants"]], "First-order electric-dipole hyperpolarizability": [[98, "first-order-electric-dipole-hyperpolarizability"]], "Symmetry aspects": [[98, "symmetry-aspects"]], "Response functions": [[99, "response-functions"], [88, "response-functions"]], "Responses to external fields": [[99, "responses-to-external-fields"]], "Defining the system": [[99, "defining-the-system"]], "Time propagation": [[99, "time-propagation"], [99, "id2"]], "Two-level system": [[99, "two-level-system"]], "Plotting observables": [[99, "plotting-observables"]], "Determining response functions": [[99, "determining-response-functions"]], "Analytic response functions": [[99, "analytic-response-functions"]], "Poles of response functions": [[99, "poles-of-response-functions"]], "Rovibronic states": [[100, "rovibronic-states"]], "Rotational Schr\u00f6dinger equation": [[100, "rotational-schrodinger-equation"]], "Numerov\u2019s method and the vibrational Schr\u00f6dinger equation": [[100, "numerov-s-method-and-the-vibrational-schrodinger-equation"]], "Numerov\u2019s method in VeloxChem": [[100, "numerov-s-method-in-veloxchem"]], "Rovibrational spectra": [[100, "rovibrational-spectra"]], "Vibronic transitions": [[100, "vibronic-transitions"]], "User defined potential": [[100, "user-defined-potential"]], "State-averaged MCSCF": [[101, "state-averaged-mcscf"]], "CASCI response": [[101, "casci-response"]], "State-specific optimization": [[101, "state-specific-optimization"]], "State-averaging": [[101, "state-averaging"]], "Selection rules": [[102, "selection-rules"]], "Time-dependent DFT": [[104, "time-dependent-dft"]], "Charge transfer": [[105, "charge-transfer"]], "Full-space results": [[106, "full-space-results"], [148, "full-space-results"]], "CVS-space results": [[106, "cvs-space-results"], [148, "cvs-space-results"]], "From VeloxChem": [[106, "from-veloxchem"]], "Comparison": [[106, "comparison"], [139, "comparison"], [148, "comparison"]], "Foundations": [[108, "foundations"]], "Runge-Gross theorem": [[108, "runge-gross-theorem"]], "Adiabatic approximation": [[108, "adiabatic-approximation"]], "In SCF theory": [[111, "in-scf-theory"]], "Quasi-energy": [[112, "quasi-energy"]], "RPA equation": [[113, "rpa-equation"]], "Eigenstates": [[113, "eigenstates"]], "Electronic Hessian": [[113, "electronic-hessian"], [86, "electronic-hessian"]], "Property gradient": [[113, "property-gradient"], [86, "property-gradient"]], "Excitation energies": [[113, "excitation-energies"]], "Intensities": [[113, "intensities"]], "Analysis": [[113, "analysis"], [125, "analysis"]], "Complex polarizability": [[113, "complex-polarizability"]], "Spin-flip": [[114, "spin-flip"]], "Tamm\u2013Dancoff approximation": [[115, "tammdancoff-approximation"]], "Triplet instability": [[116, "triplet-instability"]], "Two-photon absorption": [[117, "two-photon-absorption"]], "Wave function methods": [[118, "wave-function-methods"]], "
    Computational Chemistry from Laptop to HPC
    ": [[119, "computational-chemistry-from-laptop-to-hpc"]], "Static versus dynamic correlation correlation": [[120, "static-versus-dynamic-correlation-correlation"]], "Bond-breaking": [[120, "bond-breaking"]], "At equilibrium distance": [[120, "at-equilibrium-distance"]], "Open shells": [[121, "open-shells"]], "Restricted versus unrestricted": [[122, "restricted-versus-unrestricted"]], "High spin states": [[122, "high-spin-states"]], "Single-reference methods": [[122, "single-reference-methods"]], "Multi-reference methods": [[122, "multi-reference-methods"]], "Low spin states": [[122, "low-spin-states"]], "Single-reference methods: broken symmetry": [[122, "single-reference-methods-broken-symmetry"]], "Multi-reference solution": [[122, "multi-reference-solution"]], "UV/vis spectroscopies": [[123, "uv-vis-spectroscopies"]], "Absorption": [[124, "absorption"]], "CPP-DFT": [[124, "cpp-dft"], [145, "cpp-dft"]], "ADC": [[124, "adc"], [145, "adc"]], "CPP-ADC": [[124, "cpp-adc"]], "Comparison of spectra": [[124, "comparison-of-spectra"]], "Print and plot spectra": [[125, "print-and-plot-spectra"]], "Dominant contributions to eigenstates": [[125, "dominant-contributions-to-eigenstates"]], "Polarization dependence": [[125, "polarization-dependence"], [142, "polarization-dependence"]], "Spectrum calculation and assignment": [[126, "spectrum-calculation-and-assignment"]], "Cost-saving measures": [[126, "cost-saving-measures"], [147, "cost-saving-measures"]], "Fluorescence": [[127, "fluorescence"]], "Recommendations": [[128, "recommendations"], [149, "recommendations"]], "Electronic structure model": [[128, "electronic-structure-model"]], "Basis set selection": [[128, "basis-set-selection"], [149, "basis-set-selection"]], "Vibrational spectroscopies": [[129, "vibrational-spectroscopies"]], "IR spectroscopy": [[130, "ir-spectroscopy"]], "SCF geometry optimization": [[131, "scf-geometry-optimization"]], "Hessians": [[131, "hessians"]], "IR intensities and Raman activities": [[131, "ir-intensities-and-raman-activities"]], "Raman spectroscopy": [[132, "raman-spectroscopy"]], "Spectrum calculation": [[132, "spectrum-calculation"], [144, "spectrum-calculation"]], "Building systems": [[133, "building-systems"]], "Using SMILES": [[133, "using-smiles"]], "Bond type": [[133, "bond-type"]], "Branching and substitutions": [[133, "branching-and-substitutions"]], "Optimization using force field": [[133, "optimization-using-force-field"]], "Ring systems": [[133, "ring-systems"]], "More complex systems": [[133, "more-complex-systems"]], "Using a structure downloaded from the PDB databank": [[133, "using-a-structure-downloaded-from-the-pdb-databank"]], "Assembling a full workflow": [[134, "assembling-a-full-workflow"]], "Global warming potential": [[135, "global-warming-potential"]], "Methane combustion energy": [[136, "methane-combustion-energy"]], "Geometry optimization": [[136, "geometry-optimization"], [156, "geometry-optimization"]], "Force field optimization": [[136, "force-field-optimization"]], "xTB optimization": [[136, "xtb-optimization"], [139, "xtb-optimization"]], "Energy calculation": [[136, "energy-calculation"]], "Reaction energy": [[136, "reaction-energy"]], "Optimizing electronic structure": [[137, "optimizing-electronic-structure"]], "Specify structure": [[137, "specify-structure"]], "KS-DFT optimization": [[137, "ks-dft-optimization"]], "From structure to spectrum": [[138, "from-structure-to-spectrum"]], "Optimizing molecular structure": [[139, "optimizing-molecular-structure"]], "Initial structure": [[139, "initial-structure"]], "HF optimization": [[139, "hf-optimization"]], "Constructing workflows": [[140, "constructing-workflows"]], "X-ray spectroscopies": [[141, "x-ray-spectroscopies"]], "Spectrum analysis": [[142, "spectrum-analysis"]], "Looking at solution vectors": [[142, "looking-at-solution-vectors"]], "Eigenvectors": [[142, "eigenvectors"]], "Decomposition of spectra": [[142, "decomposition-of-spectra"]], "Atomic contributions": [[142, "atomic-contributions"]], "Special aspects": [[143, "special-aspects"]], "Relaxation": [[143, "relaxation"]], "Relaxation of core-ionized systems": [[143, "relaxation-of-core-ionized-systems"]], "Relaxation of core-(de)excitation": [[143, "relaxation-of-core-de-excitation"]], "Including relaxation with \\DeltaSCF methods": [[143, "including-relaxation-with-deltascf-methods"]], "Including relaxation with wave-function methods": [[143, "including-relaxation-with-wave-function-methods"]], "Including relaxation with DFT-based methods": [[143, "including-relaxation-with-dft-based-methods"]], "Relativity": [[143, "relativity"]], "Scalar relativistic effects": [[143, "scalar-relativistic-effects"]], "Spin-orbit coupling": [[143, "spin-orbit-coupling"]], "Basis set considerations": [[143, "basis-set-considerations"]], "Self-interaction error in DFT": [[143, "self-interaction-error-in-dft"]], "Core-hole localization": [[143, "core-hole-localization"]], "Tailored CVS": [[143, "tailored-cvs"]], "Post-HF on a non-Aufbau reference": [[143, "post-hf-on-a-non-aufbau-reference"]], "Spurious valence mixing in XAS": [[143, "spurious-valence-mixing-in-xas"]], "X-ray photoemission spectroscopy": [[144, "x-ray-photoemission-spectroscopy"]], "IEs from Koopmans\u2019 theorem": [[144, "ies-from-koopmans-theorem"]], "The maximum overlap method": [[144, "the-maximum-overlap-method"]], "IEs from \\DeltaSCF": [[144, "ies-from-deltascf"]], "Spectra from \\Delta\\textrm{SCF}": [[144, "spectra-from-delta-textrm-scf"]], "X-ray absorption spectroscopy": [[144, "x-ray-absorption-spectroscopy"]], "Decoupling from the valence continuum": [[144, "decoupling-from-the-valence-continuum"]], "Spectra from CVS-ADC": [[144, "spectra-from-cvs-adc"]], "Spectra from TDDFT": [[144, "spectra-from-tddft"], [144, "sec-xray-calc-xesdft"]], "Spectra from CPP-DFT": [[144, "spectra-from-cpp-dft"]], "Spectra from CPP-CASSCF": [[144, "spectra-from-cpp-casscf"]], "X-ray emission spectroscopy": [[144, "x-ray-emission-spectroscopy"]], "Spectra from ADC": [[144, "spectra-from-adc"]], "Spectra from ground state MOs": [[144, "spectra-from-ground-state-mos"]], "Resonant inelastic X-ray scattering": [[144, "resonant-inelastic-x-ray-scattering"]], "Two-step approach with ADC": [[144, "two-step-approach-with-adc"]], "Cheat sheet": [[145, "cheat-sheet"]], "Typical workflow": [[145, "typical-workflow"]], "IEs and XPS": [[145, "ies-and-xps"]], "Koopmans\u2019 theorem": [[145, "koopmans-theorem"]], "\\Delta-methods": [[145, "delta-methods"]], "XAS": [[145, "xas"]], "CVS-ADC": [[145, "cvs-adc"]], "XES": [[145, "xes"]], "Ground state MOs": [[145, "ground-state-mos"]], "Chemical shifts": [[146, "chemical-shifts"]], "Basis set augmentation": [[146, "basis-set-augmentation"], [146, "id1"]], "Ground-state model for XAS": [[146, "ground-state-model-for-xas"], [146, "id2"]], "The Tamm-Dancoff approximation": [[146, "the-tamm-dancoff-approximation"], [146, "id3"]], "Solutions": [[146, "solutions"]], "Chemical shift": [[146, "chemical-shift"]], "Larger systems": [[147, "larger-systems"]], "Valence-to-core XES": [[147, "valence-to-core-xes"]], "XAS of solvated systems": [[147, "xas-of-solvated-systems"]], "Uracil with CVS-ADC(2)-x": [[147, "uracil-with-cvs-adc-2-x"]], "Phthalocyanine with TDDFT": [[147, "phthalocyanine-with-tddft"]], "XES of solvated systems": [[147, "xes-of-solvated-systems"]], "Uracil with ADC(2)": [[147, "uracil-with-adc-2"]], "Phthalocyanine with DFT": [[147, "phthalocyanine-with-dft"]], "Coupling to molecular dynamics": [[147, "coupling-to-molecular-dynamics"]], "Non-standard calculations": [[148, "non-standard-calculations"]], "Transient X-ray absorption spectroscopy": [[148, "transient-x-ray-absorption-spectroscopy"]], "Valence-excited reference state": [[148, "valence-excited-reference-state"]], "Coupling valence- and core-excited eigenstates": [[148, "coupling-valence-and-core-excited-eigenstates"]], "Impact of channel restriction for TDDFT": [[148, "impact-of-channel-restriction-for-tddft"]], "Ionization energies from XAS": [[148, "ionization-energies-from-xas"]], "Ionization energies from XES": [[148, "ionization-energies-from-xes"]], "XES considered in reverse": [[148, "xes-considered-in-reverse"]], "Precision versus accuracy": [[149, "precision-versus-accuracy"]], "Electronic stucture method": [[149, "electronic-stucture-method"]], "Relativistic effects": [[149, "relativistic-effects"]], "Units and notation": [[150, "units-and-notation"]], "Atomic units": [[150, "atomic-units"]], "Unit conversion": [[150, "unit-conversion"]], "Notation": [[150, "notation"]], "Orbitals and wave functions": [[150, "orbitals-and-wave-functions"]], "Indices": [[150, "indices"]], "Matrices and vectors": [[150, "matrices-and-vectors"]], "Common matrices": [[150, "common-matrices"]], "Consistency of notation": [[150, "consistency-of-notation"]], "Short-hand notation": [[150, "short-hand-notation"]], "Spectrum broadening": [[151, "spectrum-broadening"]], "Broadening in experiment": [[151, "broadening-in-experiment"]], "Lorentzian": [[151, "lorentzian"]], "Gaussian": [[151, "gaussian"]], "Voigt": [[151, "voigt"]], "Broadening calculated spectrum": [[151, "broadening-calculated-spectrum"]], "Visual analysis of electronic transitions": [[153, "visual-analysis-of-electronic-transitions"]], "MD trajectories": [[154, "md-trajectories"]], "Molecular structure and dynamics": [[155, "molecular-structure-and-dynamics"]], "Optimization and normal modes": [[156, "optimization-and-normal-modes"]], "Vibrational normal modes": [[156, "vibrational-normal-modes"]], "Orbitals and densities": [[157, "orbitals-and-densities"]], "Using OrbitalViewer": [[157, "using-orbitalviewer"]], "Using cube-files": [[157, "using-cube-files"]], "Radial distribution": [[157, "radial-distribution"]], "Valence orbitals": [[157, "valence-orbitals"]], "Atomic sub-shell densities": [[157, "atomic-sub-shell-densities"]], "Spectra and properties": [[158, "spectra-and-properties"]], "Time-dependence of observables": [[88, "time-dependence-of-observables"]], "Representing a monochromatic electric field": [[88, null]], "Perturbation expansions": [[88, "perturbation-expansions"]], "Spin-adapted electron transfer operators": [[88, null]], "Expectation values of observables": [[88, "expectation-values-of-observables"]], "Spin-adapted electron transfer operators in VeloxChem": [[88, "spin-adapted-excitation-operators"]], "Energy determination of parameters": [[86, "energy-determination-of-parameters"]], "Order expansion of parameters": [[86, "order-expansion-of-parameters"]], "Linear response equation": [[86, "linear-response-equation"]], "Baker\u2013Campbell\u2013Hausdorff expansion": [[86, "bakercampbellhausdorff-expansion"]], "Spin-adapted excitation operators": [[86, "spin-adapted-excitation-operators"]], "Setup": [[86, "setup"]], "Response vector": [[86, "response-vector"]], "Response function": [[86, "response-function"]]}, "indexentries": {}}) \ No newline at end of file +Search.setIndex({"docnames": ["docs/basics_notebook", "docs/cite", "docs/elec_struct/available_xcfun", "docs/elec_struct/ci", "docs/elec_struct/correlation", "docs/elec_struct/dft", "docs/elec_struct/dft_prop", "docs/elec_struct/dft_scf", "docs/elec_struct/dispersion", "docs/elec_struct/elstruct_gen", "docs/elec_struct/fock_diagonalize", "docs/elec_struct/group_theory", "docs/elec_struct/hartree-fock", "docs/elec_struct/hf_example", "docs/elec_struct/hf_scf", "docs/elec_struct/hf_theory", "docs/elec_struct/hohenberg", "docs/elec_struct/integrals", "docs/elec_struct/kernel_int", "docs/elec_struct/kohn-sham", "docs/elec_struct/mcpdft", "docs/elec_struct/mcscf", "docs/elec_struct/mp2", "docs/elec_struct/multiref", "docs/elec_struct/natural_orbitals", "docs/elec_struct/operators", "docs/elec_struct/orbitals", "docs/elec_struct/pt", "docs/elec_struct/reduced_density", "docs/elec_struct/second_quant", "docs/elec_struct/slater", "docs/elec_struct/spin", "docs/elec_struct/wft", "docs/elec_struct/wft_exercises", "docs/env/chelpg", "docs/env/embedding", "docs/env/esp", "docs/env/localprop", "docs/env/loprop", "docs/env/nonpol_emb", "docs/env/pol_emb", "docs/env/resp", "docs/install", "docs/intro", "docs/mol_struct/conformer", "docs/mol_struct/coordinates", "docs/mol_struct/energy_grad", "docs/mol_struct/forcefields", "docs/mol_struct/gradients", "docs/mol_struct/hessians", "docs/mol_struct/hessians_vib", "docs/mol_struct/impes", "docs/mol_struct/impes_calc", "docs/mol_struct/md", "docs/mol_struct/md_run", "docs/mol_struct/md_setup", "docs/mol_struct/molstruct_gen", "docs/mol_struct/opt", "docs/mol_struct/opt_constrained", "docs/mol_struct/opt_gs", "docs/mol_struct/opt_struct", "docs/mol_struct/property_grad", "docs/mol_struct/reparameterize", "docs/mol_struct/symmetry", "docs/mol_struct/tst", "docs/mol_struct/tst_gen", "docs/mol_struct/vibrations", "docs/refs", "docs/spec_prop/adc", "docs/spec_prop/adc_cvs", "docs/spec_prop/adc_exercises_new", "docs/spec_prop/adc_hpc", "docs/spec_prop/adc_isr", "docs/spec_prop/adc_pp", "docs/spec_prop/birefring", "docs/spec_prop/ci", "docs/spec_prop/cubic_resp", "docs/spec_prop/dichroism", "docs/spec_prop/dipole_equiv", "docs/spec_prop/elec_nuc", "docs/spec_prop/excoupl", "docs/spec_prop/excoupl_impl", "docs/spec_prop/expt_theory", "docs/spec_prop/finite_field", "docs/spec_prop/first_order", "docs/spec_prop/hf", "docs/spec_prop/hf_param_energy", "docs/spec_prop/hf_quasienergy", "docs/spec_prop/kappa_expansion", "docs/spec_prop/linear_resp", "docs/spec_prop/mclr", "docs/spec_prop/mol_prop", "docs/spec_prop/mr_exercises", "docs/spec_prop/mr_response", "docs/spec_prop/nto", "docs/spec_prop/opa", "docs/spec_prop/orb_param_field", "docs/spec_prop/orb_rot", "docs/spec_prop/quad_resp", "docs/spec_prop/resp_external", "docs/spec_prop/rovib", "docs/spec_prop/sa_mcscf", "docs/spec_prop/selection_rules", "docs/spec_prop/spectra_aspects", "docs/spec_prop/tddft", "docs/spec_prop/tddft_charge_transfer", "docs/spec_prop/tddft_cvs", "docs/spec_prop/tddft_excited_states", "docs/spec_prop/tddft_foundation", "docs/spec_prop/tddft_linear_response", "docs/spec_prop/tddft_lr_implementation", "docs/spec_prop/tddft_lr_theory", "docs/spec_prop/tddft_quasienergy", "docs/spec_prop/tddft_rpa", "docs/spec_prop/tddft_spin_flip", "docs/spec_prop/tddft_tda", "docs/spec_prop/tddft_triplet_inst", "docs/spec_prop/tpa", "docs/spec_prop/wavefunction", "docs/title", "docs/tutorials/correlation", "docs/tutorials/openshells", "docs/tutorials/rest_unrest", "docs/tutorials/uv_vis", "docs/tutorials/uv_vis_absorption", "docs/tutorials/uv_vis_analysis", "docs/tutorials/uv_vis_exercises", "docs/tutorials/uv_vis_fluorescence", "docs/tutorials/uv_vis_rec", "docs/tutorials/vib_ir", "docs/tutorials/vib_ir_calc", "docs/tutorials/vib_ir_exercises", "docs/tutorials/vib_ir_raman", "docs/tutorials/wf_build", "docs/tutorials/wf_construct", "docs/tutorials/wf_gwp", "docs/tutorials/wf_methane", "docs/tutorials/wf_scf", "docs/tutorials/wf_spectra", "docs/tutorials/wf_struct", "docs/tutorials/workflow", "docs/tutorials/xray", "docs/tutorials/xray_analysis", "docs/tutorials/xray_aspects", "docs/tutorials/xray_calc", "docs/tutorials/xray_cheatsheet", "docs/tutorials/xray_exercises", "docs/tutorials/xray_large", "docs/tutorials/xray_nonstandard", "docs/tutorials/xray_rec", "docs/units_notation", "docs/visualize/broadening", "docs/visualize/elec_struct", "docs/visualize/exc_vis", "docs/visualize/md_vis", "docs/visualize/mol_struct", "docs/visualize/opt_vib_vis", "docs/visualize/orb_vis", "docs/visualize/spec_prop", "docs/visualize/struct_vis"], "filenames": ["docs/basics_notebook.ipynb", "docs/cite.ipynb", "docs/elec_struct/available_xcfun.ipynb", "docs/elec_struct/ci.ipynb", "docs/elec_struct/correlation.ipynb", "docs/elec_struct/dft.ipynb", "docs/elec_struct/dft_prop.ipynb", "docs/elec_struct/dft_scf.ipynb", "docs/elec_struct/dispersion.ipynb", "docs/elec_struct/elstruct_gen.ipynb", "docs/elec_struct/fock_diagonalize.ipynb", "docs/elec_struct/group_theory.ipynb", "docs/elec_struct/hartree-fock.ipynb", "docs/elec_struct/hf_example.ipynb", "docs/elec_struct/hf_scf.ipynb", "docs/elec_struct/hf_theory.ipynb", "docs/elec_struct/hohenberg.ipynb", "docs/elec_struct/integrals.ipynb", "docs/elec_struct/kernel_int.ipynb", "docs/elec_struct/kohn-sham.ipynb", "docs/elec_struct/mcpdft.ipynb", "docs/elec_struct/mcscf.ipynb", "docs/elec_struct/mp2.ipynb", "docs/elec_struct/multiref.ipynb", "docs/elec_struct/natural_orbitals.ipynb", "docs/elec_struct/operators.ipynb", "docs/elec_struct/orbitals.ipynb", "docs/elec_struct/pt.ipynb", "docs/elec_struct/reduced_density.ipynb", "docs/elec_struct/second_quant.ipynb", "docs/elec_struct/slater.ipynb", "docs/elec_struct/spin.ipynb", "docs/elec_struct/wft.ipynb", "docs/elec_struct/wft_exercises.ipynb", "docs/env/chelpg.ipynb", "docs/env/embedding.ipynb", "docs/env/esp.ipynb", "docs/env/localprop.ipynb", "docs/env/loprop.ipynb", "docs/env/nonpol_emb.ipynb", "docs/env/pol_emb.ipynb", "docs/env/resp.ipynb", "docs/install.ipynb", "docs/intro.ipynb", "docs/mol_struct/conformer.ipynb", "docs/mol_struct/coordinates.ipynb", "docs/mol_struct/energy_grad.ipynb", "docs/mol_struct/forcefields.ipynb", "docs/mol_struct/gradients.ipynb", "docs/mol_struct/hessians.ipynb", "docs/mol_struct/hessians_vib.ipynb", "docs/mol_struct/impes.ipynb", "docs/mol_struct/impes_calc.ipynb", "docs/mol_struct/md.ipynb", "docs/mol_struct/md_run.ipynb", "docs/mol_struct/md_setup.ipynb", "docs/mol_struct/molstruct_gen.ipynb", "docs/mol_struct/opt.ipynb", "docs/mol_struct/opt_constrained.ipynb", "docs/mol_struct/opt_gs.ipynb", "docs/mol_struct/opt_struct.ipynb", "docs/mol_struct/property_grad.ipynb", "docs/mol_struct/reparameterize.ipynb", "docs/mol_struct/symmetry.ipynb", "docs/mol_struct/tst.ipynb", "docs/mol_struct/tst_gen.ipynb", "docs/mol_struct/vibrations.ipynb", "docs/refs.md", "docs/spec_prop/adc.ipynb", "docs/spec_prop/adc_cvs.ipynb", "docs/spec_prop/adc_exercises_new.ipynb", "docs/spec_prop/adc_hpc.ipynb", "docs/spec_prop/adc_isr.ipynb", "docs/spec_prop/adc_pp.ipynb", "docs/spec_prop/birefring.ipynb", "docs/spec_prop/ci.ipynb", "docs/spec_prop/cubic_resp.ipynb", "docs/spec_prop/dichroism.ipynb", "docs/spec_prop/dipole_equiv.ipynb", "docs/spec_prop/elec_nuc.ipynb", "docs/spec_prop/excoupl.ipynb", "docs/spec_prop/excoupl_impl.ipynb", "docs/spec_prop/expt_theory.ipynb", "docs/spec_prop/finite_field.ipynb", "docs/spec_prop/first_order.ipynb", "docs/spec_prop/hf.ipynb", "docs/spec_prop/hf_param_energy.ipynb", "docs/spec_prop/hf_quasienergy.ipynb", "docs/spec_prop/kappa_expansion.ipynb", "docs/spec_prop/linear_resp.ipynb", "docs/spec_prop/mclr.ipynb", "docs/spec_prop/mol_prop.ipynb", "docs/spec_prop/mr_exercises.ipynb", "docs/spec_prop/mr_response.ipynb", "docs/spec_prop/nto.ipynb", "docs/spec_prop/opa.ipynb", "docs/spec_prop/orb_param_field.ipynb", "docs/spec_prop/orb_rot.ipynb", "docs/spec_prop/quad_resp.ipynb", "docs/spec_prop/resp_external.ipynb", "docs/spec_prop/rovib.ipynb", "docs/spec_prop/sa_mcscf.ipynb", "docs/spec_prop/selection_rules.ipynb", "docs/spec_prop/spectra_aspects.ipynb", "docs/spec_prop/tddft.ipynb", "docs/spec_prop/tddft_charge_transfer.ipynb", "docs/spec_prop/tddft_cvs.ipynb", "docs/spec_prop/tddft_excited_states.ipynb", "docs/spec_prop/tddft_foundation.ipynb", "docs/spec_prop/tddft_linear_response.ipynb", "docs/spec_prop/tddft_lr_implementation.ipynb", "docs/spec_prop/tddft_lr_theory.ipynb", "docs/spec_prop/tddft_quasienergy.ipynb", "docs/spec_prop/tddft_rpa.ipynb", "docs/spec_prop/tddft_spin_flip.ipynb", "docs/spec_prop/tddft_tda.ipynb", "docs/spec_prop/tddft_triplet_inst.ipynb", "docs/spec_prop/tpa.ipynb", "docs/spec_prop/wavefunction.ipynb", "docs/title.md", "docs/tutorials/correlation.ipynb", "docs/tutorials/openshells.ipynb", "docs/tutorials/rest_unrest.ipynb", "docs/tutorials/uv_vis.ipynb", "docs/tutorials/uv_vis_absorption.ipynb", "docs/tutorials/uv_vis_analysis.ipynb", "docs/tutorials/uv_vis_exercises.ipynb", "docs/tutorials/uv_vis_fluorescence.ipynb", "docs/tutorials/uv_vis_rec.ipynb", "docs/tutorials/vib_ir.ipynb", "docs/tutorials/vib_ir_calc.ipynb", "docs/tutorials/vib_ir_exercises.ipynb", "docs/tutorials/vib_ir_raman.ipynb", "docs/tutorials/wf_build.ipynb", "docs/tutorials/wf_construct.ipynb", "docs/tutorials/wf_gwp.ipynb", "docs/tutorials/wf_methane.ipynb", "docs/tutorials/wf_scf.ipynb", "docs/tutorials/wf_spectra.ipynb", "docs/tutorials/wf_struct.ipynb", "docs/tutorials/workflow.ipynb", "docs/tutorials/xray.ipynb", "docs/tutorials/xray_analysis.ipynb", "docs/tutorials/xray_aspects.ipynb", "docs/tutorials/xray_calc.ipynb", "docs/tutorials/xray_cheatsheet.ipynb", "docs/tutorials/xray_exercises.ipynb", "docs/tutorials/xray_large.ipynb", "docs/tutorials/xray_nonstandard.ipynb", "docs/tutorials/xray_rec.ipynb", "docs/units_notation.ipynb", "docs/visualize/broadening.ipynb", "docs/visualize/elec_struct.ipynb", "docs/visualize/exc_vis.ipynb", "docs/visualize/md_vis.ipynb", "docs/visualize/mol_struct.ipynb", "docs/visualize/opt_vib_vis.ipynb", "docs/visualize/orb_vis.ipynb", "docs/visualize/spec_prop.ipynb", "docs/visualize/struct_vis.ipynb"], "titles": ["Using Jupyter notebooks", "How to cite and contact", "Available XC functionals", "Configuration interaction", "Electron correlation", "Density functional theory", "First-order properties", "SCF optimization", "Dispersion interactions", "General aspects", "Fock matrix diagonalization", "Symmetry", "Hartree\u2013Fock", "HF in VeloxChem", "SCF optimization", "Hartree\u2013Fock theory", "Hohenberg\u2013Kohn theorems", "Integrals", "Kernel integration", "Kohn\u2013Sham method", "MC-PDFT", "MCSCF", "M\u00f8ller\u2013Plesset", "Multireference methods", "Natural orbitals", "Operators and matrix elements", "Orbitals and basis sets", "Rayleigh\u2013Schr\u00f6dinger perturbation theory", "Reduced particle densities", "Second quantization", "Many-electron wave functions", "Electron spin", "Wave function theory", "Exercises", "CHELPG charges", "Embedding potentials", "ESP charges", "Localized properties", "LoProp charges and polarisabilities", "Non-polarizable embedding", "Polarizable embedding", "RESP charges", "Installation", "Getting started", "Conformer search", "Choice of coordinates", "Energy gradients", "Force fields", "Gradients", "Molecular Hessians", "Hessians and vibrations", "PES interpolation techniques", "Constructing the PES by interpolation", "Molecular dynamics", "Running a simulation", "Ensembles and time integration", "General aspects", "Structure optimization", "Constrained coordinates", "Ground state", "Optimization methods", "Property gradients", "Reparameterize force fields", "Molecular symmetry", "Transition-state theory", "Transition state", "Vibrational analysis", "References", "Algebraic-diagrammatic construction", "Core-valence separation", "Exercises", "HPC-QC implementation", "Intermediate state representation", "Polarization propagator", "Birefringences and dichroisms", "Configuration interaction", "Cubic response", "Dichroism", "Dipole equivalence relations", "Electronic and nuclear contributions", "Exciton coupling model", "Implementation", "Experiment to theory", "Finite field method", "First-order properties", "Hartree\u2013Fock", "Energy determination of parameters", "Quasi-energy determination of parameters", "Time-dependence of observables", "Linear Response", "Linear response", "Molecular properties", "Exercises", "Multireference methods", "Natural transition orbitals", "UV/vis absorption", "Field-dependence of parameters", "Orbital rotations", "Quadratic response", "Responses to external fields", "Rovibronic states", "State-averaged MCSCF", "Selection rules", "General aspects", "Time-dependent DFT", "Charge transfer", "Core-valence separation", "Excited states", "Foundations", "Linear response", "Implementation", "Theory", "Quasi-energy", "RPA equation", "Spin-flip", "Tamm\u2013Dancoff approximation", "Triplet instability", "Two-photon absorption", "Wave function methods", "
    Computational Chemistry from Laptop to HPC
    ", "Static versus dynamic correlation correlation", "Open shells", "Restricted versus unrestricted", "UV/vis spectroscopies", "Absorption", "Analysis", "Exercises", "Fluorescence", "Recommendations", "Vibrational spectroscopies", "IR spectroscopy", "Exercises", "Raman spectroscopy", "Building systems", "Assembling a full workflow", "Global warming potential", "Methane combustion energy", "Optimizing electronic structure", "From structure to spectrum", "Optimizing molecular structure", "Constructing workflows", "X-ray spectroscopies", "Spectrum analysis", "Special aspects", "Spectrum calculation", "Cheat sheet", "Exercises", "Larger systems", "Non-standard calculations", "Recommendations", "Units and notation", "Spectrum broadening", "Electronic structure", "Excited states", "MD trajectories", "Molecular structure and dynamics", "Optimization and normal modes", "Orbitals and densities", "Spectra and properties", "Molecular structure"], "terms": {"we": [0, 1, 2, 3, 4, 5, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, 23, 24, 25, 26, 27, 28, 29, 30, 31, 32, 33, 34, 36, 37, 38, 39, 40, 41, 42, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 57, 58, 59, 60, 62, 64, 65, 69, 70, 71, 72, 75, 76, 78, 80, 82, 83, 84, 86, 88, 89, 90, 91, 92, 93, 94, 96, 97, 98, 99, 100, 101, 102, 103, 105, 106, 108, 111, 113, 115, 119, 120, 121, 122, 123, 124, 125, 128, 130, 131, 132, 133, 136, 137, 139, 141, 142, 143, 144, 145, 147, 148, 149, 150, 151, 153, 154, 155, 156, 157, 159], "here": [0, 3, 4, 6, 8, 11, 15, 19, 20, 21, 22, 25, 29, 33, 34, 38, 41, 45, 46, 47, 49, 52, 54, 55, 59, 60, 61, 62, 64, 66, 68, 69, 70, 71, 72, 76, 82, 86, 88, 91, 92, 96, 97, 100, 101, 104, 105, 111, 113, 122, 124, 125, 126, 128, 129, 130, 132, 136, 137, 139, 141, 142, 143, 144, 145, 147, 148, 149, 152, 153, 157, 159], "go": [0, 8, 19, 20, 21, 33, 42, 43, 70, 82, 90, 101, 130, 131, 132, 133, 143, 144, 153, 156], "over": [0, 3, 8, 15, 16, 20, 21, 24, 25, 28, 33, 38, 39, 47, 49, 52, 55, 60, 66, 70, 72, 73, 74, 76, 82, 88, 89, 91, 92, 97, 99, 100, 101, 105, 108, 111, 117, 120, 124, 132, 143, 144, 149, 150, 153], "basic": [0, 16, 33, 43, 45, 53, 55, 56, 108, 133, 141, 153], "focu": [0, 16, 29, 38, 43, 47, 82, 90, 96, 106, 124, 125, 129, 141, 142, 144, 147, 148, 149, 157, 158], "carri": [0, 7, 19, 20, 43, 45, 46, 50, 52, 66, 70, 82, 83, 156], "out": [0, 1, 3, 7, 19, 25, 27, 29, 31, 34, 36, 38, 41, 43, 45, 46, 47, 50, 52, 61, 66, 70, 73, 82, 83, 86, 88, 94, 97, 101, 115, 120, 124, 130, 142, 144, 156, 159], "analyz": [0, 18, 70, 76, 89, 101, 117, 124, 134, 153], "quantum": [0, 1, 3, 4, 5, 11, 12, 20, 26, 31, 35, 36, 39, 41, 43, 45, 47, 51, 52, 53, 61, 67, 70, 89, 99, 102, 111, 119, 120, 122, 125, 139, 143, 148, 150], "chemic": [0, 5, 16, 26, 43, 45, 47, 52, 53, 56, 64, 67, 69, 130, 139, 140, 141, 142, 143, 144, 148, 153], "well": [0, 2, 3, 5, 8, 12, 18, 20, 21, 22, 25, 27, 31, 38, 43, 44, 45, 46, 47, 52, 53, 54, 56, 57, 58, 60, 67, 70, 71, 74, 76, 88, 89, 91, 99, 100, 105, 111, 120, 121, 122, 123, 124, 125, 128, 133, 139, 142, 143, 144, 145, 148, 149, 152, 153, 154, 156], "differ": [0, 3, 4, 7, 11, 18, 20, 21, 22, 25, 29, 33, 34, 36, 37, 39, 42, 43, 46, 47, 48, 52, 53, 54, 55, 56, 59, 60, 61, 62, 65, 67, 69, 70, 72, 73, 74, 76, 80, 82, 84, 86, 88, 89, 90, 91, 98, 99, 100, 101, 103, 106, 111, 113, 120, 122, 123, 124, 128, 130, 131, 132, 133, 134, 136, 139, 140, 141, 142, 143, 144, 145, 146, 148, 149, 150, 151, 153, 157, 158, 159], "routin": [0, 10, 33, 52, 60, 62, 70, 124, 148, 154, 156, 157], "ar": [0, 1, 2, 3, 4, 5, 6, 7, 8, 9, 10, 11, 12, 14, 15, 16, 17, 18, 19, 20, 21, 22, 24, 25, 26, 27, 28, 29, 30, 31, 33, 34, 35, 36, 37, 38, 39, 40, 41, 42, 45, 46, 47, 48, 49, 52, 53, 55, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 68, 69, 70, 71, 72, 73, 74, 75, 76, 78, 80, 82, 83, 84, 86, 88, 89, 90, 91, 94, 97, 98, 99, 100, 101, 102, 103, 105, 106, 111, 113, 115, 117, 120, 122, 123, 124, 125, 126, 128, 129, 130, 132, 133, 137, 139, 140, 141, 142, 143, 144, 145, 147, 148, 149, 150, 153, 157], "echem": [0, 1, 13, 20, 21, 43, 100, 120, 125, 143, 148], "At": [0, 3, 8, 11, 33, 46, 69, 72, 82, 96, 105, 137, 143], "first": [0, 3, 4, 5, 7, 8, 10, 11, 13, 14, 15, 16, 18, 19, 20, 21, 22, 33, 34, 36, 39, 40, 41, 45, 47, 48, 49, 52, 55, 60, 61, 62, 64, 65, 66, 67, 70, 72, 73, 74, 76, 82, 83, 86, 88, 89, 90, 91, 92, 94, 96, 99, 100, 101, 103, 105, 106, 111, 113, 115, 120, 122, 124, 125, 130, 131, 132, 133, 136, 142, 144, 148, 150, 153, 154, 156], "glanc": 0, "call": [0, 3, 16, 20, 21, 42, 43, 45, 46, 49, 57, 60, 61, 66, 69, 70, 71, 72, 73, 74, 75, 81, 99, 101, 111, 120, 123, 125, 129, 143, 144], "figur": [0, 3, 4, 7, 8, 11, 14, 18, 20, 21, 28, 31, 33, 41, 43, 47, 52, 60, 62, 65, 69, 70, 73, 75, 81, 82, 92, 96, 99, 101, 102, 105, 106, 113, 120, 123, 124, 125, 130, 131, 132, 133, 142, 143, 144, 145, 148, 151, 156, 157, 159], "book": [0, 1, 13, 35, 43, 62, 67, 91, 103, 150, 153, 157], "can": [0, 3, 4, 6, 8, 10, 11, 13, 14, 16, 17, 18, 19, 20, 21, 22, 24, 25, 26, 28, 29, 31, 33, 34, 38, 39, 42, 43, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 58, 59, 60, 61, 62, 64, 65, 66, 67, 68, 70, 71, 72, 73, 74, 75, 76, 78, 80, 82, 83, 84, 86, 88, 89, 90, 91, 92, 94, 96, 97, 98, 99, 100, 101, 102, 103, 104, 105, 106, 108, 111, 113, 115, 117, 119, 120, 122, 124, 125, 128, 129, 130, 131, 133, 136, 137, 139, 140, 141, 142, 143, 144, 145, 147, 148, 149, 150, 152, 153, 154, 155, 156, 157, 159], "appear": [0, 3, 4, 5, 6, 7, 11, 13, 14, 15, 18, 20, 22, 24, 25, 26, 34, 36, 39, 41, 44, 47, 52, 58, 59, 62, 65, 70, 72, 75, 81, 82, 88, 89, 90, 91, 92, 99, 101, 102, 105, 111, 113, 115, 117, 124, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 151, 153, 154, 156, 157, 159], "bit": [0, 3, 4, 21, 90, 113, 124, 128, 143, 149], "complic": [0, 4, 20, 21, 46, 47, 55, 72, 74, 75, 141, 143, 144], "stress": [0, 133], "you": [0, 1, 3, 4, 6, 7, 11, 13, 14, 18, 20, 21, 22, 24, 25, 26, 33, 34, 36, 39, 41, 42, 43, 44, 47, 52, 58, 59, 62, 65, 70, 72, 75, 81, 88, 90, 91, 92, 101, 102, 105, 113, 115, 124, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 146, 150, 151, 153, 154, 156, 157, 159], "do": [0, 1, 3, 7, 8, 16, 17, 18, 20, 21, 33, 36, 43, 46, 49, 55, 60, 72, 75, 82, 91, 101, 103, 108, 117, 119, 120, 124, 131, 133, 139, 143, 146, 154], "need": [0, 3, 4, 6, 7, 9, 11, 13, 14, 17, 18, 20, 21, 22, 24, 25, 26, 27, 29, 33, 34, 36, 39, 40, 41, 42, 43, 44, 45, 46, 47, 49, 50, 52, 55, 58, 59, 60, 61, 62, 65, 66, 67, 69, 70, 71, 72, 75, 76, 81, 88, 89, 90, 92, 98, 101, 102, 105, 106, 113, 115, 117, 122, 124, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 148, 149, 151, 153, 154, 156, 157, 159], "rememb": [0, 20, 33, 133], "each": [0, 3, 4, 17, 19, 20, 21, 22, 25, 33, 38, 39, 40, 43, 45, 46, 47, 49, 55, 56, 60, 61, 62, 64, 70, 71, 72, 73, 90, 101, 113, 120, 123, 124, 125, 130, 131, 132, 133, 136, 141, 142, 143, 144, 148, 153, 154, 156], "necessarili": [0, 47, 75, 82, 101, 147, 149], "understand": [0, 3, 16, 21, 43, 90, 94, 102, 144, 149], "exact": [0, 3, 4, 7, 12, 19, 21, 22, 27, 31, 46, 67, 75, 84, 100, 101, 105, 108, 118, 143, 149], "detail": [0, 3, 20, 33, 39, 49, 57, 60, 61, 63, 66, 72, 73, 74, 89, 108, 122, 129, 130, 132, 133, 136, 141, 142, 143, 153], "instead": [0, 3, 7, 18, 20, 24, 33, 39, 43, 45, 46, 47, 53, 55, 62, 82, 97, 100, 109, 111, 113, 117, 122, 124, 125, 126, 128, 142, 143, 144, 146, 148, 149, 153, 154, 156], "start": [0, 3, 7, 12, 20, 21, 26, 27, 33, 38, 42, 46, 49, 52, 55, 60, 65, 66, 70, 81, 102, 106, 120, 122, 125, 132, 133, 143, 144, 146, 148, 153, 156], "copi": [0, 70, 101, 106, 125, 143, 144, 145, 148, 153], "interest": [0, 3, 20, 43, 47, 52, 53, 72, 75, 76, 89, 91, 98, 99, 101, 111, 124, 129, 133, 144, 149, 156], "experi": [0, 42, 43, 76, 84, 89, 91, 99, 103, 113, 122, 128, 143, 144, 146, 149], "plai": [0, 74], "around": [0, 4, 20, 21, 33, 47, 52, 53, 55, 62, 82, 91, 96, 108, 113, 120, 124, 139, 143, 145], "i": [0, 1, 2, 3, 4, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15, 17, 18, 19, 20, 21, 22, 24, 25, 26, 27, 28, 29, 30, 31, 33, 34, 36, 38, 39, 40, 41, 42, 43, 44, 45, 46, 47, 48, 49, 50, 52, 53, 54, 55, 57, 59, 60, 61, 62, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 78, 80, 81, 82, 83, 84, 86, 88, 89, 90, 91, 92, 94, 96, 97, 98, 99, 100, 101, 102, 103, 104, 105, 106, 108, 109, 111, 113, 115, 117, 120, 122, 123, 124, 125, 128, 129, 130, 131, 132, 133, 136, 137, 139, 141, 142, 143, 146, 147, 148, 149, 150, 151, 152, 153, 154, 156, 157, 159], "often": [0, 3, 8, 11, 20, 21, 25, 33, 42, 43, 46, 47, 55, 74, 82, 84, 89, 91, 98, 124, 128, 141, 143, 144, 147, 149, 150, 153], "one": [0, 1, 3, 4, 6, 7, 9, 10, 11, 14, 15, 16, 17, 18, 19, 20, 21, 22, 24, 28, 29, 30, 31, 33, 36, 38, 39, 42, 43, 45, 46, 47, 49, 52, 55, 59, 60, 61, 64, 65, 66, 69, 70, 72, 73, 74, 75, 76, 80, 82, 83, 84, 88, 91, 94, 96, 99, 101, 102, 103, 106, 108, 111, 113, 115, 117, 120, 122, 123, 124, 128, 130, 131, 139, 142, 143, 144, 146, 148, 153, 154, 156, 158], "best": [0, 19, 20, 21, 34, 43, 128, 143, 149], "wai": [0, 3, 5, 17, 20, 21, 23, 29, 33, 36, 37, 41, 43, 45, 46, 49, 52, 60, 66, 69, 70, 71, 72, 73, 90, 91, 101, 105, 120, 122, 128, 133, 143, 148, 149], "learn": [0, 43, 119, 144], "A": [0, 1, 2, 3, 8, 9, 11, 20, 21, 23, 24, 25, 26, 27, 29, 30, 32, 33, 36, 38, 39, 41, 43, 45, 46, 47, 52, 53, 55, 58, 65, 67, 68, 69, 70, 72, 73, 76, 78, 80, 81, 82, 83, 84, 86, 88, 89, 91, 93, 98, 101, 106, 113, 115, 118, 119, 122, 124, 130, 131, 132, 133, 140, 143, 144, 148, 149, 150, 151, 153, 156], "consist": [0, 12, 13, 15, 20, 23, 32, 39, 41, 43, 46, 49, 53, 67, 68, 69, 70, 73, 88, 90, 91, 99, 101, 108, 113, 120, 124, 125, 128, 139, 142, 143, 144, 148, 149, 153], "number": [0, 2, 3, 7, 9, 10, 13, 14, 15, 16, 17, 18, 20, 21, 22, 24, 25, 28, 29, 31, 33, 34, 36, 38, 41, 42, 43, 47, 52, 55, 60, 62, 66, 71, 72, 75, 76, 80, 82, 86, 88, 89, 90, 91, 94, 97, 98, 99, 100, 101, 105, 106, 111, 113, 115, 117, 120, 122, 123, 124, 125, 128, 133, 139, 140, 141, 142, 143, 144, 148, 150, 151, 153, 154, 156], "which": [0, 3, 5, 8, 11, 12, 14, 15, 16, 17, 19, 20, 21, 24, 25, 27, 28, 31, 33, 36, 39, 42, 43, 45, 46, 47, 49, 50, 51, 52, 53, 55, 60, 61, 63, 65, 66, 69, 70, 71, 72, 73, 74, 75, 76, 82, 84, 89, 90, 91, 92, 94, 96, 100, 101, 102, 103, 106, 108, 109, 111, 113, 117, 120, 122, 123, 124, 126, 129, 130, 131, 132, 133, 136, 139, 141, 142, 143, 144, 147, 148, 149, 152, 153, 154, 156, 157, 159], "execut": [0, 62], "ani": [0, 1, 3, 4, 11, 13, 16, 20, 21, 28, 40, 42, 46, 47, 55, 73, 82, 89, 91, 122, 124, 128, 133, 136, 137, 139, 143, 144, 145, 146, 149, 150, 154], "order": [0, 2, 3, 5, 7, 8, 15, 18, 19, 21, 22, 25, 29, 32, 33, 35, 39, 40, 42, 43, 45, 47, 48, 50, 52, 55, 60, 61, 64, 66, 67, 69, 70, 72, 73, 74, 75, 83, 88, 89, 90, 91, 94, 96, 99, 100, 101, 106, 111, 113, 117, 122, 129, 130, 133, 136, 139, 142, 143, 144, 156, 157], "most": [0, 3, 4, 5, 17, 18, 19, 20, 21, 33, 42, 44, 45, 47, 48, 55, 74, 84, 89, 91, 96, 98, 99, 101, 104, 108, 109, 111, 120, 122, 139, 141, 143, 144, 145, 147, 149, 150, 153], "relev": [0, 91, 98, 100, 133, 139, 143, 144, 153], "being": [0, 3, 5, 7, 12, 19, 21, 25, 28, 46, 47, 49, 55, 66, 74, 75, 82, 88, 89, 91, 99, 104, 108, 122, 124, 128, 142, 143, 144, 149], "where": [0, 3, 4, 5, 7, 8, 10, 14, 15, 16, 17, 18, 19, 20, 21, 22, 24, 25, 26, 27, 28, 29, 30, 31, 33, 36, 38, 39, 40, 42, 45, 46, 47, 48, 49, 52, 55, 57, 58, 60, 61, 66, 70, 71, 72, 73, 74, 75, 76, 78, 80, 82, 83, 84, 88, 89, 90, 91, 92, 94, 96, 97, 98, 99, 100, 102, 105, 106, 111, 113, 117, 120, 122, 123, 125, 142, 143, 144, 145, 146, 148, 149, 150, 153, 155, 157], "write": [0, 3, 21, 24, 29, 39, 43, 46, 52, 60, 70, 80, 82, 94, 153, 154, 156], "text": [0, 3, 7, 8, 18, 19, 21, 46, 47, 49, 60, 61, 66, 71, 72, 100, 125, 154], "equat": [0, 3, 7, 8, 11, 14, 16, 20, 21, 22, 25, 29, 33, 36, 38, 40, 41, 43, 45, 46, 47, 50, 52, 55, 60, 61, 65, 66, 67, 68, 70, 71, 72, 73, 75, 78, 82, 83, 84, 89, 91, 94, 96, 98, 99, 104, 106, 108, 111, 115, 117, 130, 136, 150], "insert": [0, 46, 55], "hyperlink": 0, "more": [0, 3, 4, 5, 8, 12, 19, 20, 21, 30, 31, 33, 34, 39, 43, 45, 46, 47, 49, 52, 55, 61, 66, 69, 70, 72, 74, 75, 76, 80, 82, 89, 91, 98, 101, 102, 103, 104, 120, 122, 124, 128, 130, 131, 132, 136, 137, 139, 141, 142, 143, 144, 148, 149, 153, 156, 157, 159], "contain": [0, 3, 11, 13, 21, 33, 35, 39, 42, 43, 45, 46, 47, 49, 55, 56, 60, 64, 72, 74, 75, 78, 82, 90, 113, 120, 140, 142, 143, 147, 148, 149], "mark": [0, 42, 73, 129, 142, 143], "press": [0, 67], "shift": [0, 46, 47, 66, 69, 70, 72, 84, 120, 124, 141, 142, 143, 144, 148, 149, 150], "enter": [0, 40, 46, 82, 96], "run": [0, 3, 4, 6, 7, 11, 13, 14, 18, 21, 22, 24, 25, 26, 28, 33, 34, 36, 38, 39, 41, 43, 44, 47, 52, 53, 58, 59, 60, 62, 65, 66, 70, 72, 75, 82, 88, 90, 92, 97, 101, 102, 105, 106, 113, 115, 117, 124, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 145, 147, 148, 151, 153, 154, 156, 157, 159], "botton": 0, "top": [0, 20, 21, 43, 60, 62, 75, 91, 101, 124, 144], "For": [0, 3, 4, 7, 8, 11, 15, 16, 17, 18, 21, 22, 24, 25, 26, 27, 28, 29, 30, 31, 33, 38, 39, 43, 45, 46, 47, 49, 52, 55, 60, 61, 63, 66, 69, 70, 72, 73, 74, 75, 76, 78, 82, 84, 86, 89, 90, 91, 96, 97, 98, 99, 100, 101, 102, 106, 108, 111, 113, 117, 119, 120, 122, 124, 130, 131, 133, 139, 141, 142, 143, 144, 148, 149, 150, 153, 155, 156], "thi": [0, 1, 3, 4, 5, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, 23, 24, 25, 26, 27, 28, 29, 30, 31, 32, 33, 35, 36, 37, 38, 39, 40, 42, 43, 45, 46, 47, 49, 50, 51, 52, 53, 54, 55, 56, 57, 60, 61, 62, 63, 64, 65, 66, 69, 70, 71, 72, 73, 74, 75, 76, 78, 80, 82, 83, 84, 86, 88, 89, 90, 91, 92, 93, 94, 96, 97, 98, 99, 100, 101, 102, 103, 104, 105, 106, 108, 109, 111, 113, 115, 117, 120, 121, 122, 123, 124, 125, 126, 128, 129, 130, 131, 133, 136, 137, 139, 140, 141, 142, 143, 144, 146, 147, 148, 149, 150, 151, 152, 153, 154, 155, 156, 157, 158, 159], "format": [0, 3, 14, 17, 33, 38, 47, 62, 65, 124, 125, 136, 142, 144, 151, 153, 156], "also": [0, 1, 3, 7, 11, 14, 15, 18, 19, 20, 21, 24, 26, 27, 29, 33, 36, 38, 43, 44, 46, 47, 49, 52, 55, 58, 60, 61, 64, 65, 69, 70, 71, 72, 73, 74, 75, 76, 82, 83, 88, 89, 90, 91, 92, 94, 96, 97, 98, 101, 102, 105, 108, 111, 113, 115, 117, 120, 122, 123, 124, 125, 129, 130, 133, 141, 143, 144, 147, 149, 150, 156, 157], "ctrl": 0, "onli": [0, 3, 4, 6, 11, 14, 16, 19, 20, 21, 22, 25, 29, 30, 33, 40, 42, 43, 46, 47, 49, 53, 55, 59, 60, 64, 65, 69, 70, 71, 72, 73, 74, 75, 80, 82, 84, 89, 90, 91, 92, 96, 97, 98, 100, 101, 102, 105, 106, 113, 122, 124, 130, 132, 137, 142, 143, 144, 147, 149, 151, 154, 156], "while": [0, 3, 18, 20, 21, 31, 45, 46, 47, 48, 49, 55, 60, 61, 64, 66, 70, 72, 73, 75, 82, 90, 101, 102, 109, 111, 120, 122, 123, 124, 129, 130, 132, 143, 144, 145, 153], "select": [0, 4, 13, 33, 42, 43, 47, 52, 55, 58, 92, 94, 100, 103, 105, 117, 131, 136, 137, 144, 152, 153, 154, 156, 157], "next": [0, 3, 14, 21, 27, 38, 39, 43, 49, 55, 57, 60, 66, 72, 75, 84, 89, 96, 101, 102, 105, 125, 139, 143, 144, 153], "from": [0, 1, 3, 4, 5, 6, 7, 8, 10, 11, 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, 24, 25, 26, 27, 28, 29, 31, 33, 36, 39, 41, 42, 43, 45, 46, 47, 49, 53, 54, 55, 56, 58, 59, 60, 61, 62, 65, 66, 67, 69, 70, 72, 73, 74, 75, 76, 80, 82, 83, 84, 86, 88, 89, 90, 91, 92, 94, 96, 97, 98, 99, 100, 101, 102, 103, 104, 105, 108, 111, 113, 117, 120, 122, 123, 124, 125, 130, 131, 132, 136, 137, 139, 141, 142, 143, 145, 146, 147, 149, 150, 151, 153, 154, 156, 157, 158, 159], "save": [0, 14, 42, 47, 52, 60, 75, 96, 105, 115, 120, 131, 133, 143, 153, 154, 156, 157], "memori": [0, 3, 17, 20, 43, 71, 72, 76, 89, 90, 98, 101, 120, 124, 148], "so": [0, 1, 3, 7, 8, 11, 14, 16, 20, 21, 22, 24, 30, 33, 36, 41, 42, 43, 46, 47, 49, 52, 55, 59, 61, 65, 66, 70, 71, 72, 74, 82, 84, 89, 90, 91, 92, 94, 97, 101, 102, 103, 113, 120, 122, 124, 133, 142, 143, 144, 147, 149, 150, 154], "good": [0, 14, 20, 21, 39, 43, 47, 52, 54, 60, 78, 91, 98, 122, 124, 128, 142, 143, 144, 149], "idea": [0, 3, 16, 19, 20, 21, 43, 52, 56, 64, 120, 144], "separ": [0, 3, 8, 11, 16, 20, 21, 22, 24, 25, 26, 27, 28, 30, 31, 33, 41, 45, 47, 66, 67, 68, 88, 99, 100, 101, 102, 104, 105, 111, 113, 129, 142, 143, 144, 147], "workflow": [0, 21, 43, 139, 141], "sever": [0, 3, 11, 13, 14, 16, 17, 19, 21, 26, 35, 42, 45, 47, 52, 53, 54, 60, 80, 82, 89, 91, 96, 99, 101, 103, 105, 111, 122, 124, 131, 133, 144, 149, 150], "block": [0, 14, 15, 17, 21, 25, 28, 33, 43, 46, 49, 69, 70, 72, 81, 86, 97, 106, 113, 115, 147], "e": [0, 1, 3, 4, 6, 7, 8, 10, 11, 13, 14, 15, 16, 19, 20, 21, 22, 25, 26, 27, 30, 31, 33, 35, 36, 38, 39, 40, 42, 43, 45, 46, 47, 48, 49, 50, 52, 53, 55, 58, 59, 60, 61, 62, 64, 66, 67, 69, 70, 71, 72, 73, 75, 76, 78, 80, 82, 83, 84, 86, 88, 90, 91, 94, 96, 97, 98, 99, 100, 101, 102, 105, 106, 111, 113, 115, 120, 122, 124, 125, 129, 130, 131, 132, 133, 139, 141, 142, 143, 144, 145, 148, 149, 150, 151, 153, 156], "g": [0, 1, 3, 6, 7, 8, 11, 14, 15, 17, 18, 21, 22, 25, 26, 38, 39, 42, 45, 46, 47, 49, 52, 53, 59, 60, 64, 65, 67, 69, 73, 82, 86, 91, 94, 99, 100, 106, 108, 111, 113, 117, 122, 124, 125, 131, 133, 139, 141, 142, 143, 144, 146, 148, 149, 150, 151, 153], "heavi": [0, 89, 91], "post": [0, 42, 100, 144], "process": [0, 3, 19, 21, 43, 47, 55, 57, 59, 60, 67, 69, 72, 73, 74, 82, 89, 91, 99, 102, 105, 109, 111, 117, 123, 128, 129, 130, 132, 140, 141, 143, 144, 148, 149], "anoth": [0, 11, 18, 20, 22, 25, 33, 43, 45, 46, 47, 49, 52, 60, 65, 71, 72, 73, 74, 99, 111, 120, 123, 129, 142, 153], "The": [0, 1, 4, 5, 6, 7, 8, 10, 11, 12, 13, 14, 15, 16, 17, 18, 19, 20, 24, 25, 26, 27, 28, 29, 30, 31, 33, 35, 36, 38, 39, 40, 41, 42, 43, 45, 46, 47, 49, 50, 53, 55, 57, 59, 60, 61, 62, 64, 65, 66, 67, 68, 69, 71, 72, 73, 74, 75, 76, 80, 81, 82, 83, 84, 86, 88, 89, 90, 91, 92, 93, 94, 96, 97, 98, 99, 100, 101, 102, 103, 104, 105, 106, 108, 111, 113, 115, 117, 118, 120, 122, 123, 124, 125, 128, 129, 130, 132, 133, 134, 136, 137, 139, 141, 142, 143, 145, 147, 148, 149, 150, 151, 152, 153, 154, 157, 158, 159], "scroll": 0, "down": [0, 13, 42, 49, 73, 80, 102, 125, 153], "window": [0, 20, 90, 101, 120, 124, 144], "edit": [0, 67], "doubl": [0, 3, 6, 7, 11, 21, 22, 26, 59, 67, 68, 69, 71, 72, 75, 76, 78, 120, 125, 133, 142, 144, 147, 149, 153, 157], "click": [0, 133], "chang": [0, 3, 11, 14, 18, 20, 21, 30, 33, 38, 39, 42, 45, 46, 47, 49, 61, 62, 70, 75, 76, 83, 84, 88, 89, 90, 91, 92, 97, 98, 101, 102, 108, 111, 113, 120, 124, 125, 126, 130, 131, 132, 136, 137, 141, 143, 144, 145, 148, 149, 153, 154, 157], "plain": 0, "lightweight": 0, "languag": [0, 43], "creat": [0, 3, 4, 22, 26, 29, 33, 39, 42, 47, 52, 55, 60, 65, 66, 69, 73, 97, 101, 105, 113, 122, 131, 132, 137, 140, 141, 142, 143, 144, 145, 148, 154, 156, 157, 159], "syntax": 0, "includ": [0, 3, 7, 21, 26, 27, 29, 30, 31, 33, 38, 40, 42, 43, 46, 47, 49, 52, 54, 55, 60, 61, 65, 66, 67, 68, 69, 72, 74, 76, 82, 88, 89, 90, 91, 97, 98, 99, 100, 101, 104, 106, 111, 120, 122, 124, 125, 128, 133, 140, 141, 142, 144, 147, 149, 150, 151, 152, 158], "head": [0, 67], "1": [0, 2, 3, 4, 6, 7, 8, 10, 11, 12, 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, 24, 25, 26, 27, 28, 29, 30, 31, 33, 34, 36, 38, 39, 41, 44, 45, 46, 47, 49, 52, 55, 58, 59, 60, 61, 62, 65, 66, 67, 69, 71, 72, 73, 75, 76, 78, 80, 81, 82, 83, 84, 86, 88, 89, 90, 91, 92, 94, 96, 97, 98, 99, 100, 101, 102, 105, 106, 108, 111, 113, 115, 117, 120, 122, 123, 124, 125, 126, 130, 131, 132, 133, 136, 137, 139, 141, 142, 143, 144, 145, 146, 148, 149, 150, 151, 153, 154, 156, 157, 159], "2": [0, 2, 3, 4, 7, 8, 10, 11, 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, 24, 25, 26, 27, 28, 29, 30, 31, 33, 34, 36, 38, 39, 41, 43, 44, 45, 46, 47, 49, 52, 55, 58, 59, 60, 61, 62, 65, 66, 67, 68, 69, 71, 73, 74, 75, 76, 78, 80, 81, 82, 83, 84, 86, 88, 89, 90, 91, 92, 94, 96, 97, 98, 99, 100, 101, 102, 105, 106, 108, 111, 113, 115, 117, 120, 122, 124, 125, 126, 128, 130, 131, 132, 133, 136, 139, 141, 142, 143, 144, 145, 146, 148, 149, 150, 151, 153, 156, 157, 159], "3": [0, 2, 3, 4, 6, 7, 8, 10, 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, 24, 25, 26, 27, 28, 29, 30, 31, 33, 34, 36, 38, 39, 41, 43, 44, 46, 47, 52, 55, 58, 59, 60, 61, 62, 65, 67, 72, 75, 76, 81, 82, 83, 84, 86, 89, 90, 91, 92, 94, 96, 98, 100, 101, 105, 106, 111, 113, 117, 120, 122, 123, 124, 125, 126, 128, 130, 131, 132, 133, 136, 139, 141, 142, 143, 144, 145, 147, 148, 149, 150, 151, 153, 156, 157, 159], "4": [0, 3, 4, 7, 8, 10, 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, 24, 25, 26, 27, 28, 31, 33, 34, 36, 38, 39, 41, 44, 46, 47, 52, 55, 58, 59, 60, 61, 62, 65, 66, 67, 69, 70, 71, 72, 75, 76, 81, 82, 83, 84, 86, 89, 90, 91, 92, 94, 97, 98, 99, 100, 101, 102, 105, 106, 113, 120, 122, 123, 124, 125, 130, 131, 132, 133, 136, 142, 143, 144, 145, 148, 150, 151, 153, 156, 157], "level": [0, 3, 4, 6, 7, 8, 18, 20, 21, 28, 31, 33, 34, 36, 38, 41, 43, 46, 47, 49, 50, 52, 67, 69, 70, 72, 73, 75, 76, 89, 92, 93, 98, 100, 101, 102, 103, 105, 120, 124, 125, 128, 129, 132, 137, 139, 141, 143, 144, 145, 148, 149, 153], "visibl": [0, 75, 103, 120, 123, 124, 129, 132], "right": [0, 4, 7, 8, 11, 16, 19, 20, 21, 22, 25, 26, 28, 29, 45, 46, 47, 49, 52, 55, 60, 61, 65, 70, 71, 72, 73, 75, 76, 78, 80, 82, 83, 84, 86, 89, 90, 97, 99, 100, 102, 106, 108, 111, 113, 117, 130, 133, 141, 143, 144, 150, 151, 157, 159], "bold": 0, "ital": 0, "have": [0, 3, 5, 7, 8, 10, 11, 15, 17, 19, 20, 21, 22, 24, 25, 28, 29, 30, 31, 33, 36, 38, 42, 43, 45, 46, 47, 49, 52, 60, 61, 65, 66, 69, 70, 71, 72, 74, 75, 76, 82, 86, 88, 89, 90, 91, 92, 94, 97, 98, 99, 100, 101, 102, 103, 105, 106, 113, 119, 120, 122, 124, 130, 131, 132, 133, 139, 141, 142, 143, 144, 148, 149, 150, 153, 154, 156], "line": [0, 8, 11, 21, 28, 42, 43, 60, 70, 73, 125, 133, 142, 143, 144, 149, 151, 153, 154, 156, 159], "break": [0, 7, 14, 20, 21, 39, 43, 47, 92, 122, 125, 143, 153, 154, 156], "like": [0, 3, 5, 17, 19, 20, 21, 45, 46, 47, 65, 69, 71, 75, 82, 92, 101, 120, 128, 131, 143, 144, 149, 154, 156], "subject": [0, 3, 43, 74, 78, 82, 88, 147], "new": [0, 3, 5, 14, 19, 33, 42, 43, 46, 47, 52, 53, 55, 60, 67, 73, 106, 131, 144, 148, 153], "link": [0, 3, 20, 39, 42, 43, 59, 62, 65, 67, 70, 131, 132, 133, 136, 139, 157, 159], "wikipedia": [0, 133, 144], "http": [0, 1, 42, 43, 67, 133], "www": 0, "org": [0, 1, 43, 67, 133, 144], "written": [0, 16, 19, 21, 22, 25, 26, 28, 29, 31, 33, 43, 46, 49, 52, 54, 55, 70, 72, 73, 75, 88, 89, 97, 113, 120, 133, 137, 143, 150], "similar": [0, 3, 8, 20, 21, 33, 45, 46, 47, 52, 55, 61, 64, 67, 72, 76, 78, 89, 90, 92, 98, 124, 139, 142, 143, 147, 148, 149], "latex": 0, "overlin": [0, 8, 10, 15, 26, 31, 97], "f": [0, 2, 3, 4, 6, 7, 8, 10, 11, 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, 24, 25, 27, 33, 34, 36, 38, 39, 41, 42, 44, 46, 49, 55, 60, 62, 67, 70, 72, 73, 74, 75, 76, 78, 81, 82, 83, 84, 86, 88, 89, 91, 92, 94, 96, 98, 99, 100, 101, 102, 105, 111, 113, 117, 122, 123, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 146, 148, 150, 151, 153, 156, 157], "m": [0, 1, 8, 21, 25, 27, 29, 31, 36, 39, 40, 41, 55, 61, 66, 67, 70, 71, 72, 73, 76, 80, 82, 84, 86, 89, 91, 98, 100, 102, 105, 106, 117, 130, 141, 148, 150], "sentenc": 0, "img": [0, 120, 153, 157], "logo": 0, "png": [0, 120], "throughout": [0, 82, 144], "abov": [0, 3, 7, 15, 18, 20, 21, 33, 36, 40, 42, 46, 47, 49, 55, 60, 70, 71, 72, 73, 75, 76, 80, 82, 84, 89, 91, 92, 101, 105, 113, 115, 122, 124, 125, 141, 142, 143, 144, 148, 149, 150, 153], "should": [0, 3, 4, 26, 38, 42, 46, 47, 49, 55, 72, 76, 82, 98, 99, 101, 113, 124, 126, 128, 133, 139, 142, 143, 144, 148, 149], "cover": [0, 9, 18, 43, 150], "main": [0, 3, 21, 24, 27, 42, 43, 47, 55, 61, 96, 99, 101, 102, 122, 143, 144], "familiar": [0, 3, 52, 128], "found": [0, 3, 15, 19, 20, 21, 22, 34, 43, 46, 47, 55, 60, 68, 78, 94, 98, 100, 102, 103, 104, 105, 108, 122, 136, 139, 143, 144, 149], "fact": [0, 4, 16, 19, 20, 21, 27, 28, 46, 47, 49, 55, 70, 72, 74, 82, 88, 90, 98, 122, 143], "mai": [0, 3, 14, 19, 20, 27, 29, 42, 43, 46, 59, 74, 76, 80, 89, 92, 98, 99, 100, 101, 108, 111, 120, 133, 139, 142, 143, 144, 147, 148, 149], "lead": [0, 3, 5, 8, 20, 21, 27, 46, 47, 49, 50, 55, 62, 65, 69, 70, 71, 72, 75, 80, 84, 89, 90, 101, 106, 115, 142, 143, 144, 148, 151], "some": [0, 1, 3, 4, 6, 7, 11, 13, 16, 17, 18, 19, 21, 22, 24, 25, 26, 27, 33, 34, 36, 39, 41, 43, 44, 45, 46, 47, 49, 52, 54, 58, 59, 60, 62, 65, 67, 68, 69, 70, 71, 72, 74, 75, 81, 88, 89, 90, 91, 92, 101, 102, 103, 105, 113, 115, 120, 124, 128, 129, 130, 131, 132, 133, 136, 137, 139, 141, 142, 143, 144, 145, 147, 148, 149, 151, 153, 154, 156, 157, 159], "confus": [0, 3], "depend": [0, 3, 4, 7, 8, 12, 15, 16, 19, 20, 21, 22, 25, 27, 33, 38, 40, 41, 42, 43, 45, 46, 47, 49, 52, 61, 67, 70, 71, 73, 74, 75, 76, 80, 82, 84, 89, 90, 97, 98, 99, 101, 103, 105, 108, 111, 117, 120, 124, 128, 129, 130, 132, 141, 143, 144, 145, 148, 149, 153], "between": [0, 3, 4, 8, 11, 14, 15, 16, 17, 18, 19, 20, 21, 24, 26, 27, 29, 31, 33, 35, 36, 39, 43, 47, 51, 52, 55, 59, 65, 67, 69, 70, 72, 73, 74, 76, 78, 80, 82, 88, 89, 90, 91, 92, 98, 99, 100, 101, 102, 103, 106, 111, 113, 117, 120, 123, 124, 129, 130, 133, 136, 139, 141, 142, 143, 144, 146, 148, 149, 150, 153, 154], "make": [0, 3, 17, 20, 21, 33, 42, 43, 46, 47, 52, 54, 55, 60, 72, 74, 75, 89, 101, 120, 122, 124, 128, 133, 141, 143, 144, 147, 148, 149, 154, 156], "sure": [0, 3, 33, 42, 60, 120, 133], "defin": [0, 3, 4, 6, 7, 18, 19, 20, 21, 26, 27, 29, 33, 36, 37, 38, 39, 44, 45, 46, 49, 52, 58, 59, 60, 61, 62, 66, 70, 72, 75, 82, 83, 84, 88, 89, 91, 94, 98, 103, 106, 108, 111, 113, 117, 124, 130, 131, 142, 144, 150, 153, 154, 156, 157], "befor": [0, 14, 20, 21, 38, 55, 60, 65, 92, 99, 100, 103, 119, 131, 133, 141, 148], "thei": [0, 3, 16, 18, 19, 20, 21, 42, 43, 46, 47, 56, 58, 66, 69, 72, 74, 78, 82, 84, 88, 89, 90, 91, 101, 105, 108, 120, 122, 128, 131, 133, 143, 144, 147, 149, 151, 153], "practic": [0, 5, 6, 14, 16, 17, 18, 20, 22, 25, 31, 43, 46, 47, 55, 60, 61, 64, 67, 71, 72, 73, 80, 82, 83, 89, 99, 100, 101, 102, 104, 105, 108, 109, 120, 123, 128, 136, 139, 141, 143, 148, 149], "restart": [0, 13, 92, 125, 143], "all": [0, 3, 7, 11, 16, 18, 19, 21, 22, 25, 26, 29, 30, 33, 34, 39, 43, 44, 45, 46, 47, 49, 50, 52, 55, 61, 64, 65, 66, 68, 70, 72, 73, 74, 75, 76, 82, 89, 90, 91, 96, 97, 98, 99, 100, 101, 102, 105, 111, 113, 117, 122, 124, 125, 130, 131, 133, 139, 142, 143, 144, 148, 150, 154, 156], "regularli": 0, "when": [0, 3, 6, 8, 11, 15, 16, 21, 25, 31, 38, 42, 43, 46, 47, 52, 53, 55, 60, 70, 72, 73, 74, 78, 80, 82, 84, 89, 91, 92, 94, 98, 100, 102, 103, 111, 121, 126, 142, 143, 144, 148, 149], "problem": [0, 19, 20, 21, 42, 43, 45, 46, 47, 55, 67, 72, 89, 98, 99, 106, 111, 120, 148, 150, 153], "occur": [0, 21, 27, 33, 46, 69, 72, 73, 74, 89, 120, 123, 143, 144, 148], "As": [0, 3, 4, 11, 14, 17, 18, 19, 21, 27, 28, 29, 31, 33, 38, 39, 42, 43, 46, 47, 49, 55, 62, 65, 66, 70, 72, 74, 75, 76, 78, 82, 84, 88, 90, 91, 92, 96, 97, 98, 99, 100, 101, 106, 113, 120, 122, 123, 124, 128, 130, 132, 133, 139, 142, 143, 144, 148, 149, 151, 153, 156, 157], "def": [0, 3, 4, 7, 14, 20, 21, 27, 29, 33, 38, 39, 47, 52, 60, 62, 65, 70, 81, 83, 86, 88, 105, 106, 113, 120, 124, 125, 130, 131, 132, 136, 143, 144, 148, 151, 153, 154, 156], "sum_numb": 0, "b": [0, 3, 7, 8, 14, 17, 18, 20, 21, 22, 25, 27, 30, 33, 38, 45, 46, 52, 66, 67, 69, 70, 72, 73, 80, 81, 82, 86, 88, 91, 96, 99, 100, 106, 113, 115, 122, 129, 132, 142, 143], "return": [0, 3, 4, 7, 13, 14, 20, 21, 27, 29, 33, 38, 39, 43, 47, 52, 58, 60, 62, 65, 70, 72, 81, 83, 86, 88, 94, 98, 106, 113, 120, 124, 125, 130, 131, 132, 133, 136, 142, 143, 144, 148, 150, 151, 154, 156], "0": [0, 1, 2, 3, 4, 6, 7, 8, 10, 11, 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, 24, 25, 26, 27, 28, 29, 31, 33, 34, 36, 38, 39, 41, 44, 45, 46, 47, 49, 52, 58, 59, 60, 61, 62, 65, 66, 72, 73, 75, 76, 78, 81, 82, 83, 84, 86, 88, 89, 90, 91, 92, 94, 96, 97, 98, 99, 100, 101, 102, 105, 106, 111, 113, 115, 117, 120, 122, 123, 124, 125, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 145, 146, 148, 149, 150, 151, 153, 154, 156, 157, 159], "assign": [0, 47, 113, 125, 142, 144, 145, 153], "variabl": [0, 16, 20, 25, 26, 33, 43, 45, 46, 47, 49, 60, 88, 91, 92, 143, 148, 153], "print": [0, 2, 3, 4, 6, 7, 10, 13, 14, 17, 18, 20, 21, 22, 24, 25, 26, 27, 28, 29, 33, 34, 36, 38, 39, 41, 44, 47, 52, 60, 62, 65, 70, 72, 75, 76, 78, 83, 86, 88, 89, 90, 94, 97, 98, 99, 100, 101, 102, 105, 113, 115, 120, 122, 124, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 145, 148, 150, 151, 153, 156], "n_sum": 0, "note": [0, 3, 7, 10, 11, 14, 15, 17, 18, 20, 21, 22, 25, 27, 33, 34, 38, 39, 41, 46, 47, 49, 54, 55, 62, 65, 67, 71, 72, 74, 76, 80, 82, 83, 86, 88, 91, 94, 96, 97, 98, 100, 101, 108, 111, 113, 115, 122, 124, 125, 128, 143, 144, 147, 148, 149, 154, 156], "automat": [0, 100, 122], "an": [0, 3, 4, 5, 6, 7, 8, 9, 10, 11, 12, 14, 15, 16, 17, 18, 19, 20, 21, 22, 23, 24, 25, 27, 28, 29, 31, 32, 33, 35, 36, 38, 39, 41, 42, 43, 44, 45, 46, 47, 49, 50, 51, 52, 55, 56, 58, 60, 61, 62, 67, 68, 69, 71, 72, 73, 74, 75, 76, 78, 80, 82, 83, 84, 88, 89, 91, 94, 96, 97, 98, 99, 100, 101, 102, 105, 111, 113, 120, 122, 123, 124, 125, 129, 130, 133, 137, 141, 142, 143, 144, 147, 148, 149, 151, 153, 154, 156, 157, 159], "integ": [0, 3, 18, 82, 100, 120], "float": [0, 33, 88, 99, 100, 156], "ad": [0, 17, 19, 33, 36, 38, 39, 41, 42, 46, 47, 53, 55, 72, 75, 89, 90, 101, 124, 127, 133, 142, 143, 144, 145, 146, 147, 148, 149, 156], "togeth": [0, 3, 9, 43, 45, 46, 47, 55, 66, 72, 105, 122, 144], "convert": [0, 40, 47, 52, 55, 61, 66, 71, 124, 136, 142, 144], "advanc": [0, 47, 67], "add": [0, 3, 7, 8, 21, 33, 36, 39, 43, 52, 60, 65, 70, 91, 92, 101, 124, 130, 131, 132, 133, 142, 146, 149, 156], "comment": [0, 1, 156], "sum": [0, 3, 16, 21, 22, 24, 25, 26, 27, 30, 33, 34, 36, 38, 39, 41, 46, 47, 49, 52, 55, 66, 70, 72, 81, 82, 88, 89, 99, 100, 108, 142, 151, 153], "tweak": 0, "posit": [0, 3, 4, 8, 16, 20, 26, 28, 29, 31, 33, 34, 36, 39, 45, 46, 47, 49, 52, 55, 60, 64, 70, 78, 83, 84, 88, 91, 98, 100, 113, 129, 130, 142, 143, 144, 153, 157, 159], "decim": 0, "notat": [0, 15, 17, 21, 22, 25, 26, 29, 33, 43, 46, 49, 70, 72, 86, 89, 91, 100, 113, 122, 133, 141], "2d": [0, 7, 14, 21, 26, 33, 39, 44, 60, 70, 81, 120, 133], "5": [0, 3, 4, 7, 8, 10, 12, 14, 17, 18, 20, 21, 22, 24, 27, 31, 33, 34, 36, 38, 41, 44, 45, 47, 52, 59, 60, 62, 65, 66, 67, 70, 72, 75, 76, 81, 82, 83, 86, 88, 89, 90, 91, 92, 96, 98, 99, 100, 101, 105, 111, 113, 115, 120, 122, 124, 125, 130, 131, 132, 136, 139, 142, 143, 144, 145, 148, 150, 151, 153, 156, 157], "4f": [0, 38, 76, 81, 89, 98, 101, 102, 105, 139, 150], "2e": [0, 7, 14, 18, 20, 21, 39, 75, 81, 90, 101, 120, 124], "0000": [0, 20, 21, 38, 76, 81, 89, 98, 102, 105, 120, 124, 125, 144, 148, 153, 156], "00e": [0, 72], "00": [0, 3, 7, 14, 20, 44, 65, 70, 72, 75, 76, 90, 100, 101, 105, 113, 120, 122, 124, 125, 131, 143, 148], "If": [0, 1, 3, 4, 6, 10, 11, 20, 21, 33, 43, 45, 46, 47, 49, 55, 60, 82, 91, 92, 94, 97, 100, 111, 120, 122, 125, 128, 129, 142, 143, 144, 149, 154, 156], "jupyterlab_code_formatt": 0, "packag": [0, 3, 20, 21, 42, 43, 54, 67, 100, 120, 125, 133, 143, 148, 157], "instal": [0, 3, 4, 6, 7, 11, 13, 14, 18, 22, 24, 25, 26, 34, 36, 39, 41, 43, 44, 47, 52, 58, 59, 62, 65, 70, 72, 75, 81, 88, 90, 92, 101, 102, 105, 113, 115, 124, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 151, 153, 154, 156, 157, 159], "environ": [0, 33, 39, 41, 43, 52, 67, 69, 92, 141, 142, 144, 147, 148, 149, 153], "command": [0, 33, 42, 43, 131], "clock": [0, 43], "symbol": [0, 31, 91, 133, 150], "instanc": [0, 22, 46, 76, 82, 84, 98, 124], "take": [0, 3, 6, 7, 10, 11, 15, 17, 19, 21, 22, 25, 26, 28, 29, 31, 33, 43, 46, 47, 49, 55, 60, 61, 64, 70, 76, 80, 82, 83, 89, 91, 99, 100, 113, 123, 124, 126, 133, 136, 144], "follow": [0, 1, 3, 4, 7, 8, 11, 14, 15, 16, 17, 18, 19, 20, 21, 24, 29, 33, 36, 38, 39, 42, 46, 49, 50, 52, 55, 60, 61, 65, 66, 68, 70, 71, 72, 73, 78, 82, 83, 84, 88, 91, 94, 96, 97, 99, 100, 101, 102, 103, 111, 117, 120, 122, 123, 128, 131, 133, 141, 143, 144, 148, 149], "import": [0, 2, 3, 4, 6, 7, 8, 10, 11, 13, 14, 17, 18, 19, 20, 21, 22, 24, 25, 26, 27, 28, 29, 31, 33, 34, 36, 38, 39, 41, 42, 43, 44, 45, 47, 48, 52, 58, 59, 60, 62, 64, 69, 70, 72, 74, 75, 76, 78, 82, 83, 86, 88, 89, 90, 91, 92, 94, 96, 97, 98, 99, 100, 101, 102, 105, 106, 108, 113, 115, 120, 122, 124, 125, 130, 131, 132, 133, 136, 137, 139, 143, 144, 145, 147, 148, 150, 151, 153, 154, 156, 157, 159], "numpi": [0, 3, 4, 6, 7, 8, 10, 13, 14, 17, 18, 20, 21, 22, 24, 25, 26, 27, 28, 29, 31, 33, 38, 39, 43, 44, 47, 52, 58, 60, 62, 65, 70, 72, 75, 78, 81, 83, 86, 88, 92, 94, 96, 97, 99, 100, 101, 105, 106, 113, 115, 120, 124, 125, 130, 131, 132, 136, 139, 143, 144, 145, 148, 151, 153, 156, 157], "matplotlib": [0, 2, 3, 4, 7, 8, 14, 18, 20, 21, 27, 28, 31, 33, 47, 52, 58, 59, 60, 62, 70, 75, 81, 92, 96, 99, 100, 101, 105, 106, 113, 120, 124, 125, 130, 131, 132, 143, 144, 145, 148, 151, 156, 157], "pyplot": [0, 2, 3, 4, 7, 8, 14, 18, 20, 21, 27, 28, 31, 33, 47, 52, 58, 59, 60, 62, 70, 75, 81, 92, 99, 100, 101, 105, 106, 113, 120, 124, 125, 130, 131, 132, 143, 144, 145, 148, 151, 156, 157], "plt": [0, 2, 3, 4, 7, 8, 14, 18, 20, 21, 27, 28, 31, 33, 47, 52, 58, 59, 60, 62, 70, 75, 81, 92, 96, 99, 100, 101, 105, 106, 113, 120, 124, 125, 130, 131, 132, 142, 143, 144, 145, 148, 151, 156, 157], "veloxchem": [0, 2, 3, 4, 5, 6, 7, 8, 10, 12, 14, 17, 18, 20, 21, 22, 24, 25, 26, 28, 33, 34, 36, 38, 39, 41, 42, 44, 46, 47, 52, 58, 59, 60, 62, 65, 70, 72, 75, 78, 81, 83, 86, 90, 92, 94, 96, 101, 102, 105, 113, 115, 120, 122, 124, 125, 130, 131, 132, 133, 136, 137, 139, 143, 144, 145, 148, 150, 151, 153, 156, 157, 159], "vlx": [0, 2, 3, 4, 6, 7, 8, 10, 13, 14, 17, 18, 20, 21, 22, 24, 25, 26, 28, 33, 34, 36, 38, 39, 41, 42, 44, 47, 52, 58, 59, 60, 62, 65, 70, 72, 75, 76, 78, 81, 83, 86, 88, 89, 90, 92, 94, 96, 98, 100, 101, 102, 105, 106, 113, 115, 120, 122, 124, 125, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 145, 148, 151, 153, 156, 157, 159], "call_funt": 0, "argument1": 0, "argument2": 0, "argument3": 0, "argument4": 0, "argument5": 0, "And": [0, 10, 26, 42, 43, 62, 86, 94, 111, 125, 137, 144], "reformat": 0, "One": [0, 3, 9, 20, 21, 47, 69, 70, 72, 73, 82, 91, 120, 124, 144, 148, 153], "advantag": [0, 3, 17, 21, 46, 47, 50, 52, 72, 124, 142], "extens": [0, 3, 4, 6, 7, 11, 13, 14, 18, 21, 22, 24, 25, 26, 34, 36, 39, 41, 43, 44, 47, 52, 58, 59, 62, 65, 70, 72, 75, 81, 88, 90, 92, 101, 102, 105, 113, 115, 124, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 151, 153, 154, 156, 157, 159], "avail": [0, 5, 17, 18, 26, 28, 42, 43, 47, 49, 54, 59, 68, 72, 76, 89, 98, 100, 113, 122, 143, 144, 145, 148, 149, 150, 157, 159], "modul": [0, 4, 7, 14, 21, 22, 38, 42, 43, 62, 66, 105, 140, 144, 148, 154, 156, 157], "larg": [0, 3, 4, 5, 8, 17, 18, 20, 21, 34, 42, 43, 47, 53, 60, 67, 68, 69, 71, 89, 98, 106, 113, 126, 128, 139, 141, 142, 143, 144, 148, 149, 150], "collect": [0, 10, 15, 22, 25, 26, 27, 29, 52, 72, 82, 94, 96, 102, 111, 113, 130, 150], "mathemat": [0, 60, 67, 82], "librari": [0, 10, 43, 76, 89, 98, 148, 159], "scipi": [0, 7, 8, 10, 14, 21, 39, 47, 58, 97, 99, 113, 124, 144, 150], "scientif": [0, 42, 43], "technic": [0, 3, 99, 108, 111, 143], "comput": [0, 1, 2, 3, 4, 6, 7, 8, 10, 13, 14, 16, 17, 18, 20, 21, 22, 24, 25, 26, 28, 33, 34, 36, 38, 39, 41, 43, 44, 45, 46, 47, 52, 53, 54, 58, 59, 60, 65, 67, 68, 69, 70, 71, 72, 75, 76, 78, 80, 83, 84, 86, 88, 89, 90, 91, 92, 94, 96, 98, 99, 100, 101, 102, 103, 104, 105, 106, 111, 113, 115, 117, 120, 122, 124, 125, 126, 128, 130, 131, 132, 136, 137, 139, 141, 142, 143, 144, 145, 148, 149, 151, 153, 157], "program": [0, 5, 10, 17, 21, 26, 38, 42, 43, 46, 54, 67, 86, 88, 101, 105], "py3dmol": [0, 18, 39, 47, 59, 60, 62, 65, 70, 81, 90, 92, 113, 115, 124, 130, 131, 132, 133, 136, 137, 139, 144, 154, 156, 157, 159], "molecul": [0, 2, 3, 4, 5, 6, 7, 8, 10, 11, 14, 17, 18, 19, 20, 21, 22, 24, 25, 28, 33, 34, 36, 37, 38, 39, 41, 43, 44, 45, 47, 49, 52, 58, 61, 62, 63, 66, 67, 68, 69, 70, 72, 74, 75, 76, 78, 82, 83, 84, 86, 88, 89, 90, 91, 92, 94, 96, 98, 99, 100, 101, 102, 105, 106, 111, 113, 115, 120, 122, 124, 125, 126, 128, 129, 130, 131, 132, 133, 134, 136, 137, 139, 142, 143, 144, 145, 148, 149, 151, 153, 156, 157, 159], "These": [0, 3, 18, 20, 21, 45, 46, 55, 58, 60, 62, 64, 69, 70, 72, 80, 82, 83, 90, 100, 103, 113, 122, 123, 128, 130, 132, 133, 139, 143, 144, 147, 149, 151, 153, 157, 159], "load": [0, 3, 4, 6, 7, 11, 13, 14, 18, 22, 24, 25, 26, 34, 36, 39, 41, 44, 47, 52, 58, 59, 62, 65, 70, 72, 75, 81, 88, 90, 92, 101, 102, 105, 113, 115, 124, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 148, 151, 153, 154, 156, 157, 159], "whole": [0, 55, 117], "given": [0, 3, 4, 8, 9, 11, 12, 15, 16, 18, 21, 22, 25, 26, 27, 28, 29, 31, 33, 38, 39, 45, 46, 49, 52, 55, 58, 60, 61, 63, 66, 68, 70, 72, 76, 82, 83, 84, 88, 89, 91, 94, 98, 99, 100, 102, 103, 115, 117, 124, 133, 143, 144, 150], "alia": 0, "avoid": [0, 21, 29, 33, 41, 46, 49, 71, 90, 120, 139, 142, 143, 144, 148], "collis": [0, 55], "overwrit": 0, "specif": [0, 4, 8, 17, 20, 21, 29, 46, 47, 54, 60, 61, 69, 72, 74, 82, 90, 102, 103, 113, 117, 120, 124, 141, 143, 144, 148, 149, 153, 156], "requir": [0, 3, 4, 14, 15, 16, 17, 24, 36, 38, 41, 42, 43, 45, 46, 47, 49, 52, 55, 56, 60, 61, 62, 67, 70, 72, 76, 82, 97, 98, 101, 108, 111, 117, 128, 130, 142, 143, 144, 148, 149, 154, 156], "p3d": [0, 18, 47, 59, 60, 62, 65, 70, 81, 90, 113, 115, 124, 130, 131, 132, 133, 136, 137, 139, 144, 154, 156], "user": [0, 17, 21, 26, 38, 43, 72, 124, 154], "other": [0, 3, 4, 6, 7, 8, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 24, 25, 26, 27, 28, 29, 31, 33, 34, 36, 39, 41, 42, 44, 46, 47, 49, 52, 55, 56, 58, 59, 60, 61, 62, 64, 65, 70, 71, 72, 73, 74, 75, 76, 81, 82, 88, 89, 90, 91, 92, 98, 101, 102, 105, 113, 115, 120, 122, 124, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 148, 149, 150, 151, 153, 154, 156, 157, 159], "experienc": [0, 14, 43, 74, 98, 141, 143], "issu": [0, 1, 3, 5, 10, 19, 20, 21, 22, 42, 43, 60, 72, 101, 105, 106, 142, 143, 144, 148, 150], "properli": [0, 20, 124, 143, 149], "due": [0, 3, 5, 8, 10, 15, 16, 17, 19, 22, 27, 31, 33, 38, 39, 41, 46, 47, 55, 68, 69, 74, 75, 82, 88, 89, 90, 92, 98, 102, 111, 113, 120, 122, 141, 142, 143, 144], "openmp": [0, 42, 43], "conflict": 0, "resolv": [0, 67, 89, 100, 106, 113, 124, 141, 142, 143, 144, 151, 153], "temporari": [0, 42, 47], "solut": [0, 3, 15, 16, 19, 20, 22, 27, 38, 39, 42, 46, 49, 61, 67, 72, 86, 88, 89, 96, 99, 100, 108, 113, 150, 153], "describ": [0, 1, 3, 4, 5, 8, 12, 16, 19, 20, 21, 23, 26, 30, 31, 32, 35, 36, 37, 45, 46, 47, 49, 50, 53, 55, 61, 66, 68, 70, 72, 73, 74, 75, 76, 78, 80, 82, 84, 88, 89, 90, 91, 92, 93, 98, 99, 100, 101, 108, 111, 117, 121, 122, 124, 125, 132, 133, 141, 144, 145, 148, 149, 150, 153], "o": [0, 2, 3, 6, 7, 10, 13, 14, 17, 18, 20, 21, 22, 24, 25, 26, 28, 34, 36, 39, 41, 42, 44, 46, 47, 52, 55, 58, 59, 62, 67, 69, 70, 71, 72, 75, 76, 82, 83, 86, 89, 90, 91, 92, 96, 98, 101, 105, 106, 113, 120, 122, 124, 125, 130, 131, 132, 133, 136, 137, 139, 143, 144, 145, 148, 151, 153, 156, 157, 159], "kmp_duplicate_lib_ok": [0, 42], "true": [0, 2, 4, 7, 8, 10, 18, 19, 20, 26, 27, 28, 31, 38, 42, 44, 46, 47, 55, 58, 59, 62, 65, 70, 72, 78, 81, 90, 94, 96, 97, 99, 100, 105, 106, 120, 122, 131, 132, 144, 148, 153], "appropri": [0, 3, 46, 66, 74, 82, 91, 113, 143, 144], "valu": [0, 3, 4, 6, 7, 8, 10, 11, 15, 18, 19, 20, 29, 30, 31, 33, 38, 39, 46, 52, 55, 58, 60, 64, 65, 70, 72, 76, 82, 84, 86, 89, 94, 98, 99, 100, 111, 113, 117, 120, 122, 125, 143, 144, 148, 150, 154, 156, 157], "pi": [0, 3, 4, 7, 8, 11, 15, 16, 19, 20, 25, 29, 31, 36, 39, 41, 46, 47, 61, 66, 67, 70, 73, 82, 91, 92, 94, 96, 97, 100, 102, 105, 113, 120, 122, 124, 130, 131, 132, 142, 143, 144, 146, 150, 151, 156, 157], "141592653589793": 0, "move": [0, 11, 29, 42, 46, 47, 55, 60, 74, 82, 94, 111, 143, 144, 148], "system": [0, 3, 4, 6, 8, 9, 11, 12, 15, 16, 17, 18, 19, 20, 21, 22, 26, 27, 28, 29, 30, 33, 34, 35, 36, 38, 39, 41, 42, 43, 46, 47, 52, 53, 55, 60, 66, 67, 69, 71, 73, 74, 76, 78, 80, 82, 83, 84, 88, 89, 90, 91, 94, 96, 97, 98, 100, 101, 102, 103, 105, 108, 109, 111, 113, 120, 121, 122, 123, 128, 130, 141, 142, 144, 148, 149, 150, 153, 159], "consid": [0, 3, 6, 8, 15, 16, 17, 21, 22, 24, 25, 26, 27, 28, 29, 33, 34, 36, 37, 38, 39, 41, 46, 47, 49, 52, 53, 55, 61, 62, 70, 73, 74, 82, 89, 91, 96, 97, 100, 102, 103, 104, 106, 111, 113, 117, 124, 128, 131, 136, 137, 141, 143, 144, 145, 146, 147, 149, 150, 151, 153, 157], "water": [0, 3, 6, 10, 13, 14, 17, 18, 21, 22, 33, 47, 67, 70, 72, 75, 83, 90, 101, 106, 124, 126, 130, 143, 144, 145, 148, 151, 153, 157, 159], "repres": [0, 3, 7, 10, 12, 19, 20, 26, 28, 31, 33, 36, 41, 46, 47, 53, 55, 60, 65, 66, 70, 72, 73, 82, 91, 100, 102, 122, 123, 143, 144, 148, 153], "xyz": [0, 18, 39, 47, 59, 62, 65, 70, 90, 92, 105, 106, 130, 131, 132, 133, 134, 136, 137, 139, 148, 156, 159], "string": [0, 3, 28, 44, 47, 58, 59, 65, 100, 125, 131, 133, 134, 136, 139, 142], "atom": [0, 4, 6, 7, 8, 10, 13, 15, 16, 17, 18, 19, 20, 21, 28, 31, 33, 34, 35, 36, 37, 39, 41, 43, 45, 46, 47, 49, 52, 53, 55, 59, 61, 62, 66, 67, 69, 70, 76, 78, 82, 89, 91, 98, 99, 100, 105, 111, 120, 122, 124, 125, 130, 131, 133, 136, 139, 141, 143, 144, 145, 148, 149, 153, 156, 159], "coordin": [0, 4, 6, 8, 16, 17, 18, 25, 28, 30, 38, 39, 43, 46, 47, 48, 49, 55, 56, 60, 61, 64, 65, 67, 84, 91, 100, 102, 105, 120, 130, 131, 132, 133, 134, 137, 143, 150, 156, 157], "\u00e5ngstr\u00f6m": 0, "water_xyz": [0, 70, 143, 144, 145, 148, 151], "0000000000": [0, 13, 20, 39, 47, 70, 75, 90, 101, 106, 120, 124, 125, 143, 144, 145, 146, 148, 151, 153, 157], "1178336003": [0, 13, 47, 70, 75, 90, 101, 106, 124, 143, 144, 145, 148, 151, 157], "h": [0, 3, 4, 6, 7, 10, 11, 13, 14, 15, 16, 17, 18, 20, 21, 22, 25, 27, 29, 31, 34, 35, 36, 38, 39, 41, 45, 46, 47, 52, 58, 59, 60, 62, 65, 66, 67, 70, 72, 75, 76, 78, 80, 81, 83, 86, 88, 89, 90, 91, 92, 94, 96, 98, 99, 100, 101, 102, 105, 106, 111, 113, 115, 117, 120, 124, 125, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 145, 146, 148, 150, 151, 153, 156, 157, 159], "7595754146": [0, 13, 47, 70, 75, 90, 101, 106, 124, 143, 144, 145, 148, 151, 157], "4713344012": [0, 13, 47, 70, 75, 90, 101, 106, 124, 143, 144, 145, 148, 151, 157], "object": [0, 3, 11, 13, 26, 39, 47, 52, 59, 62, 70, 71, 113, 124, 125, 132, 133, 137, 139, 142, 143, 144, 145, 151, 153, 156, 157], "read_xyz_str": [0, 3, 6, 7, 8, 10, 13, 14, 17, 18, 21, 22, 24, 25, 26, 33, 34, 36, 39, 41, 44, 52, 58, 59, 65, 70, 72, 75, 76, 81, 83, 86, 88, 89, 90, 94, 96, 98, 101, 102, 105, 130, 131, 132, 136, 137, 139, 143, 144, 151, 156, 157, 159], "show": [0, 2, 3, 4, 6, 7, 8, 13, 14, 15, 18, 20, 21, 22, 26, 27, 28, 30, 31, 33, 39, 43, 44, 47, 52, 58, 59, 60, 62, 65, 69, 70, 75, 81, 88, 90, 91, 92, 96, 99, 100, 101, 105, 106, 113, 120, 124, 125, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 145, 148, 151, 153, 154, 156, 157, 159], "method": [0, 2, 3, 4, 5, 6, 8, 9, 12, 13, 14, 17, 18, 24, 26, 28, 32, 34, 35, 36, 38, 39, 41, 43, 44, 46, 49, 53, 55, 56, 58, 59, 64, 67, 68, 70, 75, 84, 86, 88, 94, 99, 101, 103, 104, 117, 124, 125, 126, 128, 133, 141, 142, 148, 153], "illustr": [0, 3, 4, 9, 11, 14, 16, 17, 18, 30, 38, 39, 43, 46, 53, 55, 56, 60, 65, 69, 72, 73, 76, 82, 83, 94, 96, 98, 100, 102, 105, 113, 115, 120, 121, 122, 123, 129, 133, 139, 140, 142, 143, 144, 148, 153, 155, 157, 159], "rotat": [0, 2, 11, 21, 39, 41, 43, 46, 47, 60, 61, 62, 63, 65, 67, 70, 74, 84, 88, 90, 92, 102, 103, 130, 132, 133, 142, 143, 157, 159], "zoom": [0, 59, 124, 144, 159], "jupyterlab": [0, 3, 4, 6, 7, 11, 13, 14, 18, 22, 24, 25, 26, 34, 36, 39, 41, 42, 44, 47, 52, 58, 59, 62, 65, 70, 72, 75, 81, 88, 90, 92, 101, 102, 105, 113, 115, 124, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 151, 153, 154, 156, 157, 159], "javascript": [0, 3, 4, 6, 7, 11, 13, 14, 18, 22, 24, 25, 26, 34, 36, 39, 41, 44, 47, 52, 58, 59, 62, 65, 70, 72, 75, 81, 88, 90, 92, 101, 102, 105, 113, 115, 124, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 151, 153, 154, 156, 157, 159], "fail": [0, 3, 4, 6, 7, 11, 13, 14, 18, 21, 22, 24, 25, 26, 34, 36, 39, 41, 42, 44, 47, 52, 58, 59, 62, 65, 70, 72, 75, 81, 88, 90, 92, 101, 102, 105, 113, 115, 124, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 151, 153, 154, 156, 157, 159], "reason": [0, 3, 4, 6, 7, 8, 11, 13, 14, 18, 20, 21, 22, 24, 25, 26, 27, 33, 34, 36, 39, 41, 44, 46, 47, 52, 55, 58, 59, 60, 62, 64, 65, 70, 72, 75, 81, 88, 90, 92, 94, 98, 101, 102, 105, 108, 113, 115, 120, 122, 124, 126, 128, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 146, 148, 149, 151, 153, 154, 156, 157, 159], "3dmol": [0, 3, 4, 6, 7, 11, 13, 14, 18, 22, 24, 25, 26, 34, 36, 39, 41, 44, 47, 52, 58, 59, 62, 65, 70, 72, 75, 81, 88, 90, 92, 101, 102, 105, 113, 115, 124, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 151, 153, 154, 156, 157, 159], "labextens": [0, 3, 4, 6, 7, 11, 13, 14, 18, 22, 24, 25, 26, 34, 36, 39, 41, 44, 47, 52, 58, 59, 62, 65, 70, 72, 75, 81, 88, 90, 92, 101, 102, 105, 113, 115, 124, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 151, 153, 154, 156, 157, 159], "jupyterlab_3dmol": [0, 3, 4, 6, 7, 11, 13, 14, 18, 22, 24, 25, 26, 34, 36, 39, 41, 44, 47, 52, 58, 59, 62, 65, 70, 72, 75, 81, 88, 90, 92, 101, 102, 105, 113, 115, 124, 130, 131, 132, 133, 136, 137, 139, 142, 143, 144, 151, 153, 154, 156, 157, 159], "specifi": [0, 3, 4, 43, 46, 47, 91, 133, 144], "molecularbasi": [0, 2, 3, 4, 6, 7, 8, 10, 13, 14, 17, 18, 20, 21, 22, 24, 25, 26, 28, 33, 34, 36, 38, 39, 41, 47, 52, 65, 70, 72, 75, 76, 78, 81, 83, 86, 88, 89, 90, 92, 94, 96, 98, 100, 101, 102, 105, 106, 113, 115, 120, 122, 124, 130, 131, 132, 136, 137, 142, 143, 144, 145, 148, 151, 153, 157], "read": [0, 2, 3, 4, 6, 7, 8, 10, 13, 14, 17, 18, 19, 20, 21, 22, 24, 25, 26, 27, 28, 33, 34, 36, 38, 39, 41, 47, 52, 62, 65, 70, 72, 75, 76, 78, 81, 83, 86, 88, 89, 90, 92, 94, 96, 98, 100, 101, 102, 105, 106, 113, 115, 120, 122, 124, 125, 130, 131, 132, 133, 136, 137, 142, 143, 144, 145, 148, 151, 153, 154, 156, 157], "6": [0, 2, 3, 4, 6, 7, 8, 14, 17, 18, 20, 21, 22, 24, 26, 27, 31, 33, 34, 36, 38, 39, 41, 44, 45, 47, 52, 55, 58, 59, 60, 62, 65, 66, 70, 72, 75, 76, 81, 82, 83, 86, 88, 89, 90, 91, 92, 94, 96, 97, 98, 99, 100, 101, 102, 105, 106, 113, 115, 120, 122, 124, 125, 130, 131, 132, 136, 137, 139, 142, 143, 144, 145, 146, 148, 149, 150, 151, 153, 156, 157], "31g": [0, 3, 21, 22, 26, 34, 36, 38, 41, 47, 72, 75, 86, 90, 94, 101, 102, 105, 106, 113, 115, 124, 125, 131, 132, 142, 143, 144, 145, 146, 148, 149, 151, 153, 157], "ostream": [0, 2, 3, 4, 6, 7, 8, 10, 13, 14, 17, 18, 20, 21, 22, 24, 25, 26, 28, 33, 34, 36, 41, 44, 52, 58, 59, 72, 76, 78, 83, 86, 88, 89, 94, 96, 98, 102, 105, 115, 130, 131, 132, 136, 139, 144, 145, 153, 157], "none": [0, 2, 3, 4, 6, 7, 8, 10, 13, 14, 17, 18, 20, 21, 22, 24, 25, 26, 28, 33, 34, 36, 41, 52, 60, 76, 78, 83, 86, 88, 89, 94, 96, 98, 102, 105, 115, 124, 125, 130, 131, 132, 136, 143, 145, 153, 157], "about": [0, 11, 14, 31, 43, 47, 60, 63, 74, 92, 96, 100, 131, 142, 144, 146, 148], "adopt": [0, 6, 8, 10, 11, 14, 15, 19, 23, 32, 39, 55, 78, 82, 86, 88, 100, 105, 111, 113, 148, 150], "obtain": [0, 3, 4, 6, 7, 10, 13, 16, 18, 20, 21, 22, 24, 25, 27, 29, 33, 34, 36, 38, 39, 41, 43, 45, 46, 49, 50, 51, 52, 55, 60, 65, 66, 69, 70, 72, 73, 74, 75, 76, 78, 80, 82, 83, 86, 88, 89, 91, 93, 94, 99, 100, 101, 104, 106, 111, 113, 115, 117, 118, 122, 123, 124, 125, 130, 133, 136, 139, 142, 143, 144, 145, 146, 148, 149, 150, 157], "get_str": [0, 26], "contract": [0, 10, 13, 14, 17, 20, 21, 26, 28, 33, 46, 47, 49, 52, 61, 70, 72, 75, 82, 100, 120, 125, 143, 148], "gto": [0, 20, 21, 26, 100, 120, 125, 143, 144, 145, 148], "primit": [0, 20, 21, 26, 84, 100, 120, 125, 143, 148], "2p": [0, 21, 24, 26, 52, 90, 101, 120, 122, 124, 125, 141, 143, 144, 148, 157], "10": [0, 1, 2, 3, 4, 6, 7, 8, 12, 13, 14, 18, 20, 21, 24, 27, 31, 33, 38, 39, 44, 47, 60, 62, 65, 67, 70, 72, 75, 76, 81, 82, 83, 84, 86, 89, 90, 91, 94, 96, 98, 99, 100, 101, 105, 106, 111, 113, 120, 122, 123, 124, 125, 130, 131, 132, 142, 143, 144, 148, 150, 153, 156, 157], "4p": [0, 21, 26, 100, 120, 125, 148], "13": [0, 14, 20, 21, 24, 34, 36, 39, 41, 62, 67, 70, 72, 75, 76, 90, 98, 100, 101, 113, 120, 122, 124, 125, 143, 148, 156], "30": [0, 8, 14, 20, 21, 22, 38, 47, 62, 70, 82, 83, 84, 89, 90, 91, 101, 120, 124, 125, 131, 143, 148, 150, 156], "up": [0, 3, 21, 22, 27, 33, 35, 38, 42, 43, 45, 46, 47, 52, 55, 67, 72, 73, 74, 75, 83, 91, 96, 98, 106, 113, 117, 131, 136, 137, 139, 144, 148], "restrict": [0, 7, 9, 11, 14, 15, 20, 21, 28, 29, 33, 49, 68, 70, 82, 90, 91, 92, 100, 101, 105, 106, 120, 121, 124, 125, 126, 142, 143, 144, 145], "driver": [0, 3, 4, 7, 13, 14, 20, 21, 33, 34, 36, 41, 44, 52, 58, 70, 71, 72, 75, 76, 83, 90, 98, 100, 101, 120, 124, 125, 131, 132, 136, 137, 139, 143, 144, 148], "scf_drv": [0, 2, 3, 4, 6, 7, 8, 10, 13, 14, 17, 18, 20, 21, 22, 25, 26, 28, 33, 34, 36, 38, 39, 41, 44, 47, 52, 58, 59, 65, 70, 75, 76, 78, 83, 86, 88, 89, 90, 92, 94, 96, 98, 101, 102, 105, 106, 113, 115, 120, 124, 130, 142, 144, 148, 151, 153, 157], "scfrestricteddriv": [0, 2, 3, 4, 6, 7, 8, 10, 13, 14, 17, 18, 20, 21, 22, 25, 26, 28, 33, 34, 36, 38, 39, 41, 47, 52, 65, 75, 76, 78, 83, 86, 88, 89, 90, 92, 94, 96, 98, 101, 102, 105, 106, 113, 115, 120, 122, 124, 130, 131, 132, 136, 137, 142, 143, 144, 145, 148, 151, 153, 157], "mute": [0, 2, 3, 4, 6, 7, 8, 10, 13, 14, 17, 18, 20, 21, 22, 24, 25, 26, 28, 33, 34, 36, 41, 44, 52, 58, 59, 76, 78, 83, 86, 88, 89, 94, 96, 98, 102, 105, 115, 130, 131, 132, 136, 139, 153, 157], "scf_result": [0, 2, 3, 4, 6, 7, 8, 10, 13, 14, 17, 18, 20, 21, 22, 25, 26, 28, 33, 34, 36, 38, 39, 41, 47, 52, 65, 70, 75, 76, 78, 83, 86, 88, 89, 90, 92, 94, 96, 98, 101, 102, 105, 106, 113, 115, 120, 124, 130, 136, 142, 144, 145, 148, 151, 153, 157], "want": [0, 3, 21, 33, 42, 43, 46, 47, 92, 100, 101, 120, 133, 144], "full": [0, 2, 3, 4, 20, 21, 32, 35, 42, 47, 62, 66, 69, 90, 93, 101, 108, 113, 118, 123, 124, 133, 139, 140, 142, 143, 144, 146, 150], "output": [0, 43, 47, 65, 90, 92, 113, 124, 125], "your": [0, 1, 33, 43, 52, 126], "remov": [0, 10, 12, 15, 20, 66, 89, 90, 144], "statement": 0, "itself": [0, 3, 4, 5, 18, 31, 49, 50, 61, 74, 76, 96, 98], "long": [0, 3, 5, 19, 20, 21, 25, 33, 38, 43, 53, 67, 88, 92, 120, 128, 139], "collaps": [0, 72, 90, 144, 148], "blue": [0, 70, 105, 157], "bar": [0, 11, 15, 26, 29, 61, 66, 70, 72, 75, 80, 88, 90, 94, 97, 100, 106, 111, 124, 144, 150], "left": [0, 7, 8, 11, 16, 19, 20, 22, 25, 26, 27, 28, 29, 31, 38, 45, 46, 47, 49, 52, 55, 60, 65, 70, 71, 72, 73, 75, 76, 78, 80, 82, 83, 84, 86, 88, 89, 90, 94, 97, 99, 100, 102, 106, 108, 111, 113, 117, 124, 130, 133, 141, 142, 143, 144, 148, 150, 151], "activ": [0, 3, 19, 20, 21, 24, 33, 42, 43, 61, 67, 74, 75, 82, 90, 92, 101, 105, 120, 122, 124, 132, 150, 152, 157], "enabl": [0, 19, 31, 42, 43, 69, 71, 89, 141], "store": [0, 3, 17, 21, 33, 71, 94, 100, 113, 132, 156], "analysi": [0, 43, 50, 54, 65, 67, 69, 78, 82, 90, 96, 99, 102, 105, 123, 124, 129, 141, 144, 145, 155, 156], "further": [0, 3, 18, 45, 47, 61, 63, 65, 70, 72, 73, 80, 82, 90, 91, 96, 99, 142, 143, 148, 153], "In": [0, 3, 4, 5, 6, 7, 9, 10, 11, 12, 13, 14, 16, 17, 18, 19, 20, 21, 23, 24, 25, 26, 27, 28, 31, 32, 33, 34, 37, 38, 39, 40, 41, 42, 43, 45, 46, 47, 48, 50, 51, 52, 53, 55, 57, 60, 61, 66, 67, 69, 70, 71, 72, 74, 75, 78, 80, 82, 83, 84, 86, 88, 90, 91, 93, 94, 96, 97, 99, 100, 101, 102, 106, 108, 113, 117, 120, 121, 122, 123, 124, 129, 131, 132, 133, 136, 141, 143, 144, 147, 148, 151, 154, 156, 157], "better": [0, 20, 21, 22, 39, 47, 55, 62, 89, 90, 91, 92, 101, 113, 122, 139, 143, 144, 149, 159], "what": [0, 3, 20, 21, 43, 47, 52, 60, 61, 82, 90, 92, 96, 122, 126, 128, 131, 133, 143, 144, 146, 147, 149, 153], "docstr": 0, "inform": [0, 11, 14, 20, 25, 47, 60, 65, 70, 74, 82, 91, 100, 120, 123, 124, 125, 141, 142, 143, 144, 145, 148], "get": [0, 3, 4, 6, 7, 10, 11, 15, 17, 18, 20, 21, 22, 24, 27, 28, 29, 33, 38, 39, 46, 47, 52, 65, 70, 72, 75, 76, 78, 82, 83, 86, 88, 89, 94, 96, 97, 98, 100, 113, 120, 122, 124, 131, 132, 133, 142, 143, 144, 149, 150, 156, 157], "help": [0, 72, 73, 90, 128, 130, 149], "scfrestdriv": [0, 131], "class": [0, 3, 4, 13, 16, 18, 19, 22, 28, 29, 34, 36, 41, 59, 60, 62, 64, 72, 75, 76, 86, 89, 94, 98, 106, 113, 115, 131, 144], "scfdriver": 0, "comm": [0, 72, 125, 144, 145], "implement": [0, 3, 5, 10, 12, 14, 16, 20, 23, 29, 32, 33, 36, 39, 43, 45, 46, 52, 59, 67, 68, 83, 88, 89, 97, 106, 124, 148, 153], "spin": [0, 3, 9, 11, 12, 13, 15, 19, 20, 22, 24, 26, 28, 29, 30, 33, 38, 67, 70, 72, 90, 100, 101, 120, 124, 125, 128, 141, 144, 148, 149, 150, 157], "close": [0, 4, 5, 6, 7, 8, 11, 14, 15, 19, 20, 21, 24, 25, 28, 29, 31, 38, 39, 47, 55, 59, 60, 67, 70, 74, 86, 88, 91, 97, 101, 102, 113, 121, 122, 123, 131, 132, 133, 141, 143, 144, 148, 149, 154, 156], "shell": [0, 7, 11, 14, 15, 18, 20, 24, 25, 28, 29, 31, 38, 67, 70, 86, 88, 91, 92, 97, 102, 113, 122, 148, 149], "c2": [0, 67, 81, 133], "dii": [0, 7, 14, 67], "two": [0, 3, 7, 8, 9, 10, 11, 14, 16, 18, 19, 20, 21, 22, 24, 26, 27, 31, 33, 35, 36, 39, 45, 46, 47, 49, 55, 59, 60, 61, 62, 68, 69, 70, 71, 72, 73, 74, 78, 80, 84, 86, 88, 91, 97, 98, 100, 102, 111, 113, 120, 122, 123, 124, 125, 130, 132, 133, 142, 143, 145, 146, 148, 153], "converg": [0, 3, 7, 20, 21, 25, 27, 33, 39, 41, 43, 55, 60, 65, 67, 70, 72, 75, 76, 83, 89, 90, 92, 98, 100, 101, 106, 120, 124, 125, 142, 143, 144, 145, 148, 153], "acceler": [0, 7, 20, 21, 55, 67, 70, 120, 125, 143, 148, 150], "param": [0, 60, 70], "mpi": [0, 43, 125, 145], "commun": [0, 5, 71], "stream": 0, "resolut": [0, 67, 124, 151], "builtin": 0, "__deepcopy__": 0, "self": [0, 12, 13, 15, 19, 20, 23, 29, 32, 41, 43, 46, 49, 67, 70, 90, 101, 108, 120, 124, 125, 141, 142, 144, 148, 149], "memo": 0, "deepcopi": [0, 143, 144, 145, 148], "__init__": [0, 29, 144], "initi": [0, 3, 7, 14, 20, 33, 39, 42, 52, 55, 58, 59, 60, 62, 64, 65, 69, 70, 72, 73, 74, 75, 90, 92, 100, 102, 108, 120, 124, 125, 126, 129, 133, 143, 144, 148, 153, 159], "default": [0, 3, 6, 7, 18, 20, 21, 36, 42, 46, 65, 113, 122, 137], "setup": [0, 8, 20, 27, 34, 36, 41, 70, 72, 76, 81, 82, 89, 98, 100, 120, 125, 143, 148], "threshold": [0, 3, 10, 20, 41, 60, 70, 72, 75, 76, 83, 89, 90, 98, 100, 101, 120, 124, 125, 142, 143, 148], "guess": [0, 3, 7, 14, 20, 21, 26, 33, 39, 64, 70, 72, 92, 100, 120, 125, 143, 144, 148], "etc": [0, 19, 30, 43, 99, 111, 142, 149], "base": [0, 3, 8, 14, 15, 21, 26, 33, 38, 41, 42, 43, 46, 47, 49, 50, 52, 55, 60, 62, 67, 68, 70, 73, 80, 83, 96, 99, 102, 105, 115, 122, 129, 130, 149, 153, 156], "constructor": 0, "get_scf_type_str": 0, "overload": 0, "inherit": [0, 117], "ao_basi": [0, 144], "min_basi": 0, "data": [0, 8, 43, 47, 51, 52, 58, 60, 62, 65, 70, 76, 91, 92, 100, 105, 131, 132, 133, 141, 153, 154, 156, 157], "minim": [0, 3, 4, 7, 12, 14, 15, 16, 19, 20, 21, 26, 34, 36, 38, 42, 47, 60, 64, 70, 71, 92, 101, 139, 143, 148, 149, 157], "compute_s2": [0, 122], "scf_tensor": [0, 70, 72, 81, 86], "expect": [0, 3, 4, 6, 10, 15, 20, 22, 29, 31, 39, 41, 46, 72, 80, 82, 84, 89, 90, 96, 99, 101, 106, 111, 120, 122, 128, 131, 143, 144, 149], "": [0, 3, 7, 10, 11, 13, 14, 15, 17, 19, 20, 21, 22, 24, 25, 26, 28, 29, 31, 33, 34, 36, 38, 39, 40, 41, 42, 43, 45, 46, 47, 49, 52, 53, 54, 55, 60, 61, 65, 66, 67, 70, 71, 72, 73, 74, 75, 76, 81, 82, 89, 90, 91, 92, 96, 98, 101, 105, 106, 111, 113, 117, 120, 122, 123, 124, 130, 132, 133, 143, 144, 146, 148, 150, 153, 156], "oper": [0, 3, 6, 7, 9, 10, 14, 15, 16, 17, 21, 22, 26, 27, 31, 38, 41, 46, 56, 63, 69, 72, 73, 75, 76, 78, 82, 84, 89, 90, 91, 94, 97, 98, 99, 100, 102, 106, 111, 113, 117, 122, 123, 143, 148], "tensor": [0, 8, 13, 38, 40, 61, 66, 71, 74, 76, 83, 84, 88, 89, 98, 117, 132, 143, 150], "wavefunct": [0, 3, 20, 21, 23, 33, 75, 90, 91, 93, 101, 120, 122, 124], "get_scf_energi": [0, 2, 3, 4, 7, 8, 13, 14, 20, 21, 24, 25, 33, 47, 52, 72, 120, 122, 136, 137, 143, 144], "previou": [0, 3, 14, 19, 21, 33, 39, 42, 46, 55, 60, 66, 72, 75, 82, 91, 97, 101, 137, 139, 143, 144, 156], "iter": [0, 3, 6, 7, 15, 20, 21, 33, 39, 41, 43, 46, 47, 59, 60, 65, 67, 70, 72, 75, 76, 89, 90, 98, 100, 101, 105, 113, 120, 124, 125, 143, 144, 148, 156], "maximum_overlap": [0, 122, 143, 144], "alpha_list": 0, "beta_list": 0, "constraint": [0, 3, 14, 15, 19, 36, 41, 46, 47, 58, 143, 144, 145, 148], "find": [0, 1, 4, 15, 20, 21, 28, 30, 31, 36, 42, 43, 44, 46, 48, 55, 57, 60, 66, 72, 76, 84, 91, 92, 94, 97, 113, 122], "maxim": [0, 64, 139, 144], "overlap": [0, 7, 13, 14, 15, 20, 21, 24, 38, 39, 46, 49, 67, 70, 72, 96, 106, 111, 120, 122, 125, 143, 147, 148, 150], "refer": [0, 1, 3, 6, 8, 11, 15, 16, 18, 19, 21, 24, 25, 26, 28, 29, 30, 31, 33, 34, 36, 41, 42, 43, 45, 46, 47, 49, 50, 54, 66, 73, 76, 82, 83, 86, 88, 89, 90, 91, 96, 98, 103, 104, 108, 111, 113, 120, 124, 128, 144, 145, 146, 149, 150, 152], "molecularorbit": [0, 21], "alpha": [0, 3, 4, 6, 7, 8, 13, 15, 17, 18, 19, 20, 24, 26, 28, 31, 33, 36, 38, 41, 47, 49, 60, 61, 70, 71, 75, 76, 78, 82, 83, 84, 86, 88, 89, 91, 96, 97, 98, 99, 105, 111, 113, 117, 120, 122, 132, 142, 143, 144, 150, 153, 157], "occupi": [0, 3, 4, 7, 10, 11, 14, 15, 17, 18, 20, 21, 22, 24, 25, 26, 28, 29, 30, 31, 33, 46, 49, 70, 72, 75, 80, 86, 88, 90, 94, 96, 97, 101, 111, 113, 115, 120, 122, 124, 125, 141, 142, 143, 144, 149, 150, 157], "beta": [0, 3, 6, 7, 13, 15, 17, 18, 19, 20, 24, 26, 28, 31, 33, 36, 38, 41, 47, 70, 71, 74, 75, 76, 78, 82, 83, 84, 88, 89, 91, 96, 97, 98, 111, 113, 117, 120, 122, 143, 144, 150, 153, 157], "print_attribut": 0, "attribut": [0, 1], "print_keyword": [0, 100], "input": [0, 17, 43, 47, 100, 133], "keyword": [0, 3], "set_start_orbit": 0, "arrai": [0, 3, 4, 7, 8, 10, 13, 18, 20, 21, 24, 27, 33, 38, 39, 43, 44, 47, 52, 60, 62, 70, 75, 81, 83, 86, 88, 92, 97, 99, 101, 106, 113, 120, 131, 132, 142, 143, 148, 156, 157], "checkpoint": [0, 132, 143, 156], "file": [0, 20, 21, 26, 39, 43, 47, 62, 65, 67, 70, 92, 94, 100, 105, 120, 125, 131, 132, 133, 143, 148, 153, 154, 156, 159], "tupl": [0, 13], "update_set": [0, 33, 41, 81, 100, 106, 113, 122, 124, 131, 132, 142, 144, 148, 151, 153], "scf_dict": [0, 33, 153], "method_dict": [0, 153], "updat": [0, 3, 21, 22, 33, 42, 60, 131, 132, 143, 144], "dicitonari": 0, "write_checkpoint": 0, "nuclear_charg": 0, "basis_set": [0, 4, 18, 78, 136, 143], "nuclear": [0, 3, 7, 11, 14, 15, 16, 20, 25, 28, 33, 38, 39, 45, 46, 47, 48, 49, 50, 55, 60, 61, 66, 67, 70, 83, 89, 100, 103, 120, 125, 130, 141, 143, 148, 150], "charg": [0, 4, 8, 11, 19, 20, 25, 26, 31, 35, 37, 39, 40, 47, 61, 62, 67, 70, 80, 81, 82, 84, 91, 104, 120, 125, 128, 141, 143, 144, 148, 150, 153], "name": [0, 3, 4, 13, 14, 16, 18, 19, 20, 22, 25, 29, 42, 46, 59, 62, 70, 72, 73, 76, 81, 82, 88, 94, 98, 101, 113, 122, 150, 154], "readonli": 0, "properti": [0, 3, 5, 11, 12, 16, 19, 21, 29, 33, 39, 40, 43, 45, 47, 48, 66, 67, 68, 74, 76, 78, 89, 93, 97, 98, 99, 101, 103, 106, 109, 111, 117, 118, 124, 129, 141, 143, 144, 148, 149, 150, 153], "densiti": [0, 2, 6, 7, 8, 9, 12, 13, 14, 15, 16, 17, 21, 23, 24, 26, 31, 36, 39, 40, 43, 46, 61, 67, 69, 72, 73, 75, 76, 80, 89, 94, 96, 98, 101, 104, 105, 108, 111, 120, 122, 125, 126, 137, 142, 143, 145, 148, 150, 152, 158], "matrix": [0, 3, 4, 6, 9, 12, 14, 15, 18, 20, 21, 24, 27, 28, 29, 30, 36, 38, 39, 41, 43, 45, 46, 49, 50, 52, 60, 61, 66, 67, 69, 71, 73, 75, 76, 80, 82, 86, 88, 94, 96, 97, 98, 106, 115, 117, 120, 125, 130, 132, 143, 144, 148, 150, 153], "is_converg": [0, 21, 33], "whether": [0, 46, 50, 144], "mol_orb": [0, 2, 3, 4, 8, 13, 17, 20, 21, 22, 24, 25, 33, 70, 75, 86, 90, 92, 101, 102, 113, 120, 122, 124, 125, 137, 142, 143, 144, 157], "backward": [0, 21, 65], "compat": 0, "molecular_orbit": [0, 20, 21, 24, 120, 122], "nnode": 0, "node": [0, 17, 43, 70, 71, 72, 76, 89, 98, 148, 157], "num_it": 0, "current": [0, 5, 21, 42, 43, 55, 60, 89, 104, 124, 125, 143, 144, 147, 150], "rank": [0, 84, 91, 113, 117], "scf_energi": [0, 13, 39, 52, 83], "scf_type": [0, 13], "descriptor": [0, 142], "__dict__": 0, "__weakref__": 0, "weak": [0, 43, 47, 55, 76, 82, 92, 106, 111, 143, 144, 149, 150], "filenam": [0, 94, 105, 120, 153], "getter": 0, "protect": 0, "final": [0, 3, 7, 11, 13, 14, 20, 21, 31, 33, 43, 46, 49, 51, 55, 59, 62, 65, 66, 69, 70, 75, 82, 88, 90, 92, 97, 100, 101, 102, 120, 123, 124, 125, 126, 129, 139, 140, 142, 143, 144, 148, 149, 153], "see": [0, 3, 8, 20, 21, 22, 33, 39, 42, 43, 46, 47, 51, 52, 55, 59, 60, 63, 65, 69, 70, 72, 73, 75, 78, 82, 90, 91, 101, 105, 106, 113, 120, 122, 124, 125, 129, 133, 137, 139, 141, 142, 143, 144, 148, 150, 153, 154, 156, 159], "access": [0, 4, 6, 8, 18, 36, 43, 65, 72, 113], "auto": [0, 113], "complet": [0, 3, 4, 11, 20, 21, 29, 38, 46, 55, 67, 72, 78, 96, 136, 149, 153], "tab": 0, "option": [0, 58, 60, 65, 133], "same": [0, 3, 4, 6, 18, 19, 20, 21, 22, 25, 28, 29, 31, 33, 42, 43, 46, 47, 49, 50, 55, 60, 69, 70, 72, 73, 75, 76, 82, 98, 106, 113, 120, 122, 123, 129, 132, 133, 142, 143, 144, 148, 150, 153], "75": [0, 7, 8, 14, 18, 20, 28, 33, 39, 47, 52, 60, 70, 75, 76, 89, 90, 100, 101, 120, 124, 130, 131, 132, 143, 148, 156, 157], "98387037576917": 0, "light": [0, 8, 11, 38, 61, 66, 67, 74, 75, 82, 89, 91, 92, 98, 103, 111, 113, 117, 120, 123, 129, 130, 132, 144, 150, 157], "weight": [0, 3, 6, 7, 14, 18, 21, 22, 24, 46, 47, 49, 52, 90, 101, 122, 124, 149, 153, 157], "interact": [0, 2, 4, 9, 15, 19, 21, 22, 31, 32, 35, 39, 40, 43, 46, 62, 67, 69, 72, 73, 74, 82, 91, 111, 115, 118, 120, 124, 133, 141, 142, 144, 149, 153, 154, 156, 157], "orbitalview": [0, 13, 21, 70, 92, 94, 102, 113, 120, 125, 137, 152, 153], "viewer": [0, 13, 21, 33, 39, 47, 59, 62, 65, 70, 90, 92, 94, 102, 113, 120, 124, 125, 131, 132, 133, 136, 137, 139, 153, 154, 156, 157, 159], "provid": [0, 3, 4, 5, 12, 16, 18, 19, 21, 26, 33, 39, 43, 46, 47, 52, 62, 68, 69, 70, 74, 86, 89, 94, 99, 101, 102, 111, 113, 121, 124, 125, 128, 133, 139, 141, 142, 143, 144, 145, 146, 148, 149, 150, 153, 157], "seven": [0, 24, 122], "drop": [0, 3, 90, 149], "menu": [0, 13, 102], "lower": [0, 3, 18, 20, 22, 31, 38, 41, 47, 58, 60, 72, 83, 89, 94, 101, 102, 106, 113, 122, 124, 129, 130, 133, 142, 143, 144, 148], "sto": [0, 3, 4, 21, 26, 33, 47, 52, 65, 70, 130, 139, 157], "3g": [0, 3, 4, 11, 21, 26, 33, 47, 52, 65, 70, 130, 139, 157], "yield": [0, 16, 46, 47, 49, 66, 70, 72, 76, 82, 91, 109, 111, 128, 141, 142, 143, 144, 148, 149], "per": [0, 26, 36, 41, 47, 72, 94, 100, 136, 143, 148, 150], "hydrogen": [0, 4, 20, 31, 33, 36, 38, 39, 41, 47, 120, 124, 131, 132, 133, 139, 144, 149, 150], "five": [0, 11, 17, 18, 29, 38, 46, 66, 83, 115, 136], "oxygen": [0, 3, 10, 18, 21, 24, 39, 67, 90, 92, 101, 122, 124, 139, 143, 144, 145, 159], "three": [0, 16, 19, 26, 31, 33, 39, 46, 47, 52, 55, 66, 67, 76, 80, 82, 91, 99, 100, 111, 117, 123, 130, 132, 133, 142, 150], "upper": [0, 31, 38, 53, 102, 113, 124, 142, 157], "isosurfac": 0, "under": [0, 1, 7, 11, 14, 15, 16, 19, 20, 30, 42, 76, 82, 91, 98, 103, 130, 153], "neg": [0, 3, 20, 33, 39, 46, 49, 64, 65, 70, 88, 91, 100, 122, 144, 148, 153, 157], "treat": [0, 21, 75, 82, 88, 120], "individu": [0, 3, 17, 28, 29, 46, 47, 55, 66, 71, 78, 80, 89, 91, 154, 156], "abl": [0, 3, 13, 20, 21, 46, 52, 69, 82, 111, 153, 157], "compil": [0, 62, 153, 157], "It": [0, 3, 4, 5, 6, 7, 8, 10, 11, 12, 14, 15, 18, 20, 21, 22, 26, 31, 38, 42, 43, 45, 46, 47, 49, 60, 64, 70, 71, 72, 74, 82, 83, 86, 89, 90, 92, 97, 99, 100, 105, 108, 111, 113, 117, 120, 122, 143, 144, 148, 149, 153, 157], "work": [0, 3, 4, 18, 25, 26, 42, 43, 45, 46, 52, 54, 55, 82, 91, 104, 108, 123, 128, 133, 142, 143, 144, 147, 148, 149, 153, 154, 156, 157], "though": [0, 20, 21, 98, 144, 153, 157], "let": [0, 3, 4, 6, 7, 8, 10, 14, 16, 17, 18, 20, 21, 22, 24, 25, 27, 29, 30, 31, 33, 34, 36, 38, 39, 41, 43, 46, 52, 58, 60, 70, 71, 74, 75, 76, 78, 82, 83, 86, 89, 90, 92, 94, 96, 97, 98, 101, 102, 105, 120, 122, 124, 130, 132, 143, 156], "u": [0, 1, 2, 3, 4, 6, 7, 8, 10, 11, 13, 14, 15, 16, 17, 18, 20, 21, 22, 24, 27, 28, 29, 30, 31, 33, 34, 36, 38, 39, 41, 43, 45, 46, 49, 52, 58, 60, 62, 67, 70, 72, 74, 75, 76, 78, 82, 83, 86, 88, 89, 90, 91, 94, 96, 97, 98, 99, 100, 101, 102, 105, 111, 113, 120, 122, 124, 125, 131, 132, 141, 143, 144, 148, 150, 153, 154, 157], "impact": [0, 115, 136, 141, 144, 147], "total": [0, 3, 7, 12, 18, 20, 21, 22, 24, 25, 28, 29, 31, 33, 34, 36, 38, 39, 41, 45, 46, 49, 55, 70, 72, 73, 80, 83, 84, 90, 91, 100, 101, 120, 122, 124, 125, 136, 137, 139, 142, 143, 144, 148], "gener": [0, 1, 6, 7, 14, 15, 16, 18, 20, 21, 23, 26, 28, 29, 30, 31, 40, 43, 45, 46, 47, 48, 49, 52, 60, 62, 66, 67, 68, 72, 73, 74, 75, 76, 82, 84, 88, 89, 91, 93, 98, 99, 101, 111, 113, 117, 120, 122, 123, 124, 128, 129, 133, 136, 141, 143, 144, 148, 149, 150, 154, 159], "trend": [0, 20, 144, 149], "increas": [0, 3, 4, 17, 20, 22, 27, 39, 47, 53, 71, 78, 89, 91, 101, 120, 124, 128, 133, 142, 143, 144], "size": [0, 18, 21, 26, 31, 43, 55, 60, 67, 68, 69, 70, 71, 75, 76, 82, 89, 98, 115, 142, 143, 144, 148, 153, 157], "calc_scf": 0, "n_ba": [0, 143], "get_dimensions_of_basi": [0, 4, 7, 10, 13, 14, 18, 21, 24, 26, 28, 38, 106], "empti": [0, 3, 21, 33, 52, 75, 122, 142], "basis_s": 0, "element": [0, 3, 4, 9, 11, 14, 15, 21, 24, 26, 28, 29, 30, 33, 38, 39, 41, 45, 46, 47, 52, 61, 66, 67, 69, 70, 71, 72, 73, 75, 76, 80, 82, 84, 86, 88, 91, 94, 97, 98, 105, 113, 117, 130, 131, 132, 139, 141, 143, 144, 149, 150, 156], "modifi": [0, 3, 7, 18, 25, 33, 43, 46], "place": [0, 8, 11, 20, 25, 33, 38, 69, 70, 73, 82, 123], "within": [0, 3, 12, 16, 19, 20, 21, 27, 43, 46, 47, 55, 67, 72, 75, 80, 82, 88, 90, 91, 101, 113, 133, 143, 144, 148], "bracket": [0, 82], "list_exampl": 0, "cat": 0, "dog": 0, "Or": [0, 106, 131, 132], "loop": [0, 3, 33, 47, 59, 60, 62, 65, 70, 92, 130, 131, 132, 154, 156], "718281828459045": 0, "311g": [0, 26, 136, 137, 143, 144, 149], "31": [0, 3, 14, 20, 24, 26, 62, 67, 89, 90, 97, 100, 101, 120, 124, 131, 143, 150, 156], "311": [0, 26, 143, 146, 149], "design": [0, 33, 41, 43, 52, 67, 74, 82, 89, 94, 103, 124, 150], "mean": [0, 3, 7, 9, 10, 15, 16, 20, 21, 22, 27, 28, 29, 30, 34, 36, 38, 41, 43, 46, 47, 49, 53, 55, 58, 61, 64, 69, 72, 75, 82, 83, 94, 96, 97, 101, 102, 106, 113, 122, 124, 130, 141, 143, 144, 149, 150, 153], "elsewher": [0, 28, 84, 149], "energy_tmp": 0, "n_bas_tmp": 0, "append": [0, 3, 4, 7, 8, 14, 18, 20, 21, 22, 27, 33, 38, 39, 44, 47, 52, 60, 62, 70, 75, 81, 86, 92, 96, 101, 106, 113, 120, 124, 131, 142, 143, 144, 148, 156], "hang": 0, "too": [0, 3, 20, 47, 55, 75, 82, 89, 101, 113, 120, 128, 143, 144, 147, 149], "kernel": [0, 5, 6, 42, 46, 49, 143, 144, 145, 148], "appeal": [0, 83], "figsiz": [0, 2, 3, 4, 7, 8, 14, 18, 20, 21, 28, 31, 33, 47, 52, 58, 59, 60, 62, 70, 75, 81, 92, 96, 99, 100, 101, 106, 113, 120, 124, 125, 130, 131, 132, 142, 143, 144, 145, 148, 151, 156, 157], "titl": [0, 3, 20, 21, 31, 33, 43, 52, 62, 70, 75, 92, 101, 105, 113, 120, 124, 130, 131, 132, 142, 143, 144, 151, 153, 156, 157], "nicer": [0, 159], "circl": [0, 4, 74, 82], "point": [0, 4, 6, 7, 8, 12, 19, 20, 21, 22, 27, 33, 34, 35, 36, 38, 39, 41, 45, 46, 47, 48, 49, 50, 51, 52, 56, 60, 64, 65, 66, 70, 73, 76, 82, 83, 84, 88, 89, 91, 96, 98, 99, 100, 102, 103, 122, 123, 143, 144, 148, 149, 157], "connect": [0, 19, 42, 43, 47, 72, 74, 82, 91, 103, 117, 133, 139], "dash": [0, 4, 113, 120, 143, 157], "d": [0, 3, 6, 7, 8, 11, 13, 14, 15, 16, 17, 18, 19, 21, 22, 24, 25, 28, 29, 30, 34, 36, 38, 39, 40, 41, 45, 46, 49, 60, 61, 66, 67, 69, 70, 71, 72, 73, 82, 83, 84, 86, 91, 94, 100, 105, 129, 130, 131, 132, 143, 150, 151, 153, 156], "color": [0, 4, 8, 14, 18, 20, 31, 39, 47, 52, 58, 60, 70, 99, 101, 105, 113, 120, 124, 125, 143, 157, 159], "red": [0, 18, 38, 60, 70, 101, 105, 157, 159], "label": [0, 3, 4, 7, 8, 14, 16, 18, 19, 20, 21, 26, 27, 28, 33, 34, 36, 41, 46, 49, 52, 58, 60, 61, 66, 70, 72, 75, 81, 91, 92, 96, 100, 101, 105, 120, 131, 132, 133, 141, 143, 148, 151, 156], "legend": [0, 3, 4, 7, 8, 14, 18, 20, 21, 27, 28, 33, 47, 52, 58, 60, 62, 70, 75, 81, 92, 96, 100, 101, 105, 106, 113, 120, 124, 131, 132, 142, 143, 144, 148, 156, 157], "xlim": [0, 4, 18, 27, 28, 31, 47, 70, 99, 124, 142, 143, 144, 157], "37": [0, 20, 24, 62, 67, 90, 98, 101, 120, 122, 125, 143, 144, 148, 156], "limit": [0, 6, 11, 14, 20, 21, 30, 38, 46, 53, 55, 67, 76, 78, 82, 83, 86, 89, 91, 98, 113, 136, 144, 149, 154], "x": [0, 1, 3, 4, 7, 8, 10, 11, 17, 18, 19, 20, 21, 24, 31, 33, 39, 43, 45, 46, 47, 49, 52, 60, 61, 66, 67, 69, 70, 71, 72, 73, 75, 81, 82, 88, 89, 90, 91, 92, 94, 96, 100, 101, 102, 104, 106, 111, 113, 115, 120, 122, 124, 125, 128, 129, 130, 131, 132, 134, 142, 143, 145, 146, 149, 150, 151, 153, 156, 157], "axi": [0, 4, 6, 8, 11, 20, 28, 31, 38, 52, 60, 66, 82, 83, 84, 88, 96, 98, 105, 113, 120, 124, 131, 143, 156, 157], "ylim": [0, 4, 8, 18, 28, 31, 47, 70, 92, 99, 105, 124, 143, 144, 157], "76": [0, 7, 8, 13, 14, 20, 39, 67, 75, 76, 90, 101, 120, 124, 125, 143, 148, 156], "74": [0, 7, 14, 20, 21, 24, 52, 70, 120, 143, 156], "8": [0, 3, 7, 8, 14, 18, 20, 21, 24, 27, 28, 31, 33, 34, 36, 38, 39, 44, 46, 58, 60, 62, 65, 67, 70, 72, 75, 76, 81, 82, 83, 84, 86, 88, 89, 90, 91, 97, 98, 100, 101, 102, 105, 113, 115, 120, 122, 123, 124, 125, 131, 133, 136, 142, 143, 144, 145, 148, 150, 151, 153, 156, 157], "y": [0, 1, 8, 11, 14, 17, 18, 20, 21, 24, 31, 33, 38, 45, 46, 47, 49, 60, 61, 67, 70, 72, 75, 81, 82, 88, 89, 90, 91, 92, 100, 101, 106, 111, 113, 120, 124, 125, 130, 131, 132, 142, 143, 144, 148, 150, 151, 156, 157, 159], "grid": [0, 2, 6, 7, 8, 28, 34, 36, 41, 46, 58, 60, 62, 76, 89, 96, 98, 99, 100, 148], "xlabel": [0, 4, 7, 8, 14, 18, 20, 27, 28, 31, 33, 47, 52, 62, 70, 96, 99, 100, 101, 105, 113, 120, 130, 131, 132, 143, 144, 156, 157], "ylabel": [0, 2, 3, 4, 7, 8, 14, 18, 20, 27, 28, 31, 33, 47, 52, 62, 70, 75, 96, 99, 100, 101, 105, 113, 120, 130, 131, 132, 143, 144, 156, 157], "hartre": [0, 3, 4, 5, 6, 7, 8, 13, 14, 19, 20, 21, 24, 25, 27, 28, 32, 34, 36, 38, 39, 41, 43, 46, 49, 50, 70, 72, 80, 88, 89, 92, 96, 97, 100, 104, 105, 108, 111, 113, 120, 121, 122, 125, 136, 137, 143, 150], "clear": [0, 3, 18, 21, 25, 47, 55, 99, 101, 105, 111, 120, 142, 144, 150], "decreas": [0, 4, 55, 60, 80, 98, 143], "larger": [0, 3, 18, 20, 21, 25, 27, 33, 35, 39, 47, 52, 55, 89, 96, 97, 122, 123, 124, 129, 133, 139, 142, 143, 144, 148, 149, 153], "flexibl": [0, 4, 21, 43, 47, 122, 143, 149], "alwai": [0, 3, 20, 21, 47, 60, 89, 133, 143, 149, 150], "case": [0, 3, 7, 8, 14, 15, 18, 20, 21, 22, 24, 25, 26, 27, 28, 31, 33, 38, 43, 45, 46, 47, 49, 50, 55, 60, 61, 67, 69, 70, 74, 75, 76, 78, 82, 84, 86, 88, 89, 91, 94, 96, 98, 99, 100, 101, 103, 111, 113, 117, 120, 122, 123, 124, 128, 132, 133, 139, 143, 144, 149, 154], "smaller": [0, 3, 4, 20, 25, 27, 33, 72, 82, 89, 123, 129, 143, 144, 148], "suitabl": [0, 17, 55, 65, 89, 99, 133, 145, 149], "particular": [0, 3, 7, 14, 19, 20, 21, 31, 43, 46, 47, 60, 62, 72, 74, 75, 82, 86, 89, 90, 91, 101, 131, 141, 143, 148], "concept": [0, 3, 4, 19, 21, 32, 39, 43, 45, 65, 91, 94, 101], "chemistri": [0, 1, 3, 4, 5, 9, 12, 26, 35, 43, 45, 67, 99, 120, 141, 149], "paramet": [0, 3, 19, 21, 22, 26, 35, 39, 43, 46, 47, 55, 62, 76, 88, 90, 97, 98, 111, 113, 124, 144, 150, 154], "typic": [0, 3, 19, 21, 35, 42, 47, 60, 82, 83, 88, 90, 91, 101, 113, 115, 120, 123, 128, 133, 141, 142, 143, 144, 148, 149, 150, 155], "wish": [0, 1, 43, 97, 157], "carbon": [0, 26, 28, 34, 41, 67, 120, 136, 141, 142, 143, 144, 150], "monoxid": [0, 26, 28], "track": [0, 3], "bond": [0, 3, 4, 5, 19, 20, 21, 26, 33, 38, 39, 41, 45, 52, 53, 59, 65, 88, 92, 96, 100, 101, 130, 139, 144], "length": [0, 33, 45, 47, 52, 55, 60, 66, 75, 78, 90, 100, 101, 117, 120, 124, 139, 144, 148, 150], "distanc": [0, 3, 4, 8, 18, 20, 21, 33, 38, 47, 52, 58, 100, 102, 105, 124, 139, 153, 157], "arang": [0, 27, 47, 52, 60, 70, 81, 99, 100, 105, 106, 113, 124, 125, 130, 131, 132, 142, 143, 144, 148, 151, 156], "linspac": [0, 4, 8, 20, 28, 31, 58, 83, 96, 113, 120, 143, 157], "evenli": 0, "space": [0, 2, 3, 4, 11, 20, 21, 22, 25, 26, 31, 33, 34, 38, 46, 49, 60, 67, 69, 70, 71, 72, 75, 76, 82, 84, 89, 90, 91, 92, 96, 97, 98, 101, 113, 120, 122, 124, 126, 128, 142, 143, 144, 146, 147, 150, 152, 157], "interv": [0, 47, 100, 143], "either": [0, 1, 15, 33, 38, 42, 43, 46, 47, 48, 55, 60, 61, 66, 84, 124, 128, 131, 133, 134, 143, 149, 153, 154], "step": [0, 3, 11, 17, 21, 27, 38, 40, 46, 47, 52, 55, 56, 60, 64, 66, 75, 81, 88, 99, 108, 125, 130, 131, 132, 143, 145, 148, 154, 156], "give": [0, 4, 11, 16, 18, 20, 21, 26, 27, 38, 46, 47, 49, 55, 65, 66, 70, 72, 74, 75, 88, 90, 98, 102, 103, 105, 115, 123, 139, 142, 144], "end": [0, 3, 6, 8, 11, 14, 15, 16, 17, 19, 20, 22, 24, 25, 26, 27, 28, 29, 30, 31, 33, 36, 38, 39, 43, 45, 46, 47, 49, 55, 60, 71, 76, 81, 82, 83, 84, 86, 88, 89, 91, 94, 97, 98, 99, 102, 106, 111, 113, 117, 122, 125, 143, 144], "stop": 0, "num": 0, "7": [0, 1, 3, 4, 7, 8, 14, 18, 20, 21, 24, 25, 27, 28, 33, 38, 44, 52, 60, 61, 62, 65, 67, 70, 72, 75, 76, 81, 89, 90, 91, 98, 100, 101, 102, 105, 113, 120, 122, 123, 124, 125, 130, 131, 136, 142, 143, 144, 148, 150, 153, 156, 157], "9": [0, 3, 7, 8, 14, 18, 20, 21, 24, 26, 27, 31, 33, 38, 41, 44, 60, 62, 65, 67, 70, 72, 75, 76, 81, 83, 89, 90, 100, 101, 105, 113, 115, 120, 122, 123, 124, 125, 131, 136, 143, 144, 148, 150, 156], "ensur": [0, 16, 19, 29, 38, 42, 46, 60, 86, 98, 101, 133], "replac": [0, 3, 7, 8, 14, 20, 21, 33, 46, 47, 49, 52, 55, 101, 105, 120, 133, 139, 143, 153], "start_str": 0, "john": [0, 67], "went": 0, "bowl": 0, "jane": 0, "end_str": 0, "andrew": 0, "cinema": 0, "sarah": 0, "co_bas": [0, 47], "c": [0, 3, 7, 8, 10, 11, 13, 14, 15, 17, 18, 21, 22, 24, 25, 26, 28, 33, 34, 36, 38, 39, 40, 41, 43, 46, 47, 49, 58, 59, 61, 65, 66, 67, 69, 70, 72, 73, 75, 76, 81, 82, 84, 86, 88, 89, 91, 92, 94, 96, 98, 102, 105, 106, 113, 115, 120, 125, 129, 131, 132, 133, 136, 137, 139, 142, 143, 144, 146, 148, 150, 153, 156, 157, 159], "l": [0, 2, 3, 4, 14, 15, 17, 19, 20, 26, 27, 36, 38, 46, 47, 61, 66, 67, 71, 72, 76, 82, 89, 91, 94, 98, 100, 120, 141, 143, 148, 149], "bond_": [0, 47], "bond_l": [0, 47], "40": [0, 3, 4, 8, 20, 21, 24, 47, 60, 62, 65, 70, 75, 76, 83, 84, 86, 88, 90, 91, 98, 99, 100, 101, 120, 122, 124, 125, 143, 148, 150, 156], "04": [0, 7, 14, 18, 20, 21, 47, 65, 72, 75, 76, 81, 89, 90, 98, 100, 101, 113, 120, 124, 125, 139, 143, 148, 156], "co_tmp": [0, 47], "smoother": [0, 144], "aesthet": 0, "pleas": [0, 1, 60, 150], "piec": [0, 33, 52, 53], "wise": [0, 139], "polynomi": 0, "desir": [0, 21, 33, 38, 55, 72, 73, 124, 144, 148, 149], "cubic": [0, 8, 34, 47, 58, 83, 89, 113, 117, 124, 142, 144], "tend": [0, 20, 74, 128, 142, 144, 149], "rel": [0, 3, 19, 31, 34, 36, 41, 47, 53, 70, 91, 100, 101, 122, 124, 125, 128, 129, 139, 141, 142, 144, 146, 148, 149, 150], "smooth": [0, 20, 21, 27], "curv": [0, 8, 20, 21, 47, 58, 62, 92, 100], "spline_func": [0, 58], "interp1d": [0, 8, 47, 58, 113, 124, 142, 144], "kind": [0, 8, 11, 47, 58, 113, 124, 142, 144], "x_spline": [0, 58], "min": [0, 27, 44, 47, 58, 59, 60, 70, 72, 75, 76, 81, 89, 90, 98, 100, 113, 124, 142, 143, 144, 148, 154, 156], "max": [0, 3, 20, 33, 38, 41, 60, 70, 72, 75, 76, 81, 86, 89, 90, 98, 99, 100, 101, 113, 120, 124, 125, 139, 142, 143, 144, 148, 151, 154, 156], "100": [0, 1, 3, 4, 7, 20, 22, 28, 33, 60, 62, 67, 72, 81, 82, 113, 120, 143, 149, 150, 154, 156, 157], "y_spline": [0, 58], "stretch": [0, 21, 52, 53, 100, 120, 130, 131, 132], "approxim": [0, 3, 4, 5, 7, 14, 15, 16, 20, 21, 22, 26, 27, 31, 41, 46, 47, 53, 55, 60, 67, 69, 80, 84, 86, 88, 90, 91, 94, 98, 99, 100, 101, 104, 111, 113, 117, 128, 132, 136, 141, 143, 144, 149], "e_k": 0, "frac": [0, 3, 7, 8, 10, 15, 16, 19, 21, 22, 25, 28, 29, 30, 31, 33, 36, 38, 39, 41, 45, 46, 47, 49, 52, 55, 60, 61, 65, 66, 70, 72, 73, 74, 75, 76, 78, 80, 82, 83, 84, 86, 88, 89, 91, 96, 97, 98, 99, 100, 108, 111, 117, 122, 130, 150, 151], "k_": [0, 7, 8, 47, 150], "l_0": [0, 47], "Such": [0, 15, 16, 27, 73, 82, 102, 111, 143], "form": [0, 3, 5, 6, 7, 9, 10, 11, 14, 17, 19, 21, 25, 26, 28, 29, 30, 31, 35, 38, 46, 47, 49, 55, 67, 70, 73, 74, 76, 78, 80, 82, 83, 84, 89, 91, 96, 97, 99, 100, 102, 105, 111, 113, 120, 122, 124, 144, 148, 150], "forc": [0, 25, 35, 50, 53, 54, 55, 67, 91, 139, 150, 156], "field": [0, 3, 12, 13, 15, 20, 23, 31, 32, 33, 35, 38, 43, 46, 49, 53, 54, 55, 61, 67, 70, 74, 75, 76, 78, 84, 86, 89, 90, 98, 100, 101, 102, 103, 108, 111, 120, 122, 124, 125, 139, 143, 148, 150], "dynam": [0, 5, 20, 21, 23, 43, 47, 51, 52, 54, 55, 61, 67, 70, 74, 75, 76, 91, 98, 101, 125, 143, 144, 148, 154, 159], "optim": [0, 3, 5, 6, 8, 10, 18, 19, 20, 21, 25, 38, 39, 43, 45, 46, 47, 48, 53, 56, 58, 59, 62, 64, 67, 83, 89, 96, 102, 115, 122, 124, 126, 132, 140, 143, 144, 145, 148, 153, 155, 157], "curve_fit": [0, 47], "minima": [0, 8, 45, 47, 57, 60], "bond_e_shift": 0, "harmonic_func": 0, "popt": 0, "pcov": 0, "shape": [0, 3, 10, 17, 22, 33, 47, 52, 60, 70, 81, 86, 113, 151, 156], "wrong": [0, 21], "locat": [0, 18, 21, 39, 42, 45, 47, 67, 124, 133], "incorrect": [0, 6], "factor": [0, 3, 7, 14, 15, 29, 30, 31, 33, 36, 38, 55, 66, 82, 84, 88, 91, 94, 97, 124, 125, 141, 144, 145, 150, 151, 157], "inadequaci": 0, "somewhat": [0, 18, 21, 46, 72, 97, 108, 133], "unsuit": [0, 141, 149], "region": [0, 8, 18, 19, 20, 28, 35, 36, 39, 40, 43, 47, 60, 69, 74, 92, 96, 99, 100, 113, 122, 123, 124, 131, 142, 143, 144, 149], "discuss": [0, 3, 5, 11, 12, 21, 22, 30, 42, 43, 45, 48, 49, 51, 54, 57, 60, 61, 64, 69, 70, 72, 73, 82, 84, 91, 94, 103, 104, 108, 117, 123, 125, 126, 129, 130, 132, 136, 140, 141, 143, 146, 147, 148, 149, 151, 153, 155, 158], "our": [0, 3, 7, 10, 18, 20, 21, 26, 29, 33, 36, 38, 39, 52, 60, 62, 70, 82, 86, 88, 90, 91, 92, 96, 101, 113, 115, 120, 122, 137, 144, 149, 154], "softwar": [0, 26, 42, 54], "einsum": [0, 3, 6, 7, 10, 14, 17, 18, 21, 22, 24, 25, 27, 28, 33, 38, 39, 52, 70, 75, 83, 86, 88, 96], "simpl": [0, 3, 18, 20, 21, 43, 45, 46, 47, 52, 53, 55, 60, 65, 67, 75, 82, 84, 90, 100, 102, 105, 122, 144, 149, 153], "tool": [0, 3, 5, 21, 67, 74, 91, 153, 155], "descri": 0, "manual": [0, 43, 89, 139, 144], "vector": [0, 3, 4, 14, 16, 20, 21, 25, 26, 27, 28, 29, 31, 33, 38, 43, 46, 52, 61, 66, 70, 71, 72, 73, 74, 76, 82, 84, 88, 89, 90, 91, 94, 98, 105, 111, 113, 120, 124, 125, 143, 148], "n": [0, 4, 6, 7, 8, 11, 13, 14, 15, 17, 18, 19, 20, 21, 22, 24, 25, 26, 27, 28, 29, 31, 33, 38, 39, 42, 44, 45, 46, 47, 49, 55, 61, 65, 66, 67, 69, 70, 71, 72, 73, 74, 75, 78, 80, 81, 82, 84, 86, 88, 89, 90, 91, 92, 94, 97, 99, 106, 113, 115, 117, 120, 122, 124, 125, 130, 131, 132, 133, 136, 141, 142, 143, 144, 153, 156, 157, 159], "nb": 0, "sai": [0, 21, 72, 82, 122], "c_i": [0, 3, 21, 30], "sum_j": [0, 21, 52, 72, 82], "a_ib_": 0, "ij": [0, 3, 7, 10, 14, 15, 17, 21, 22, 25, 27, 33, 36, 39, 45, 46, 47, 49, 52, 66, 70, 71, 72, 80, 86, 106, 113, 144, 150], "singl": [0, 3, 9, 11, 12, 15, 20, 21, 24, 26, 28, 29, 33, 46, 47, 49, 67, 69, 71, 72, 73, 75, 76, 90, 91, 97, 104, 105, 108, 111, 113, 115, 117, 120, 121, 128, 133, 142, 143, 144, 146, 148, 149, 151], "12": [0, 2, 3, 6, 7, 14, 17, 20, 21, 22, 24, 27, 28, 31, 33, 39, 41, 44, 47, 52, 62, 67, 70, 72, 75, 76, 78, 81, 83, 86, 88, 89, 90, 94, 97, 98, 100, 101, 102, 105, 113, 120, 122, 124, 125, 131, 142, 143, 144, 148, 150, 153, 156], "36": [0, 20, 24, 70, 94, 100, 101, 120, 122, 125, 143, 156], "j": [0, 1, 3, 4, 7, 14, 15, 16, 17, 19, 20, 21, 22, 25, 27, 28, 29, 31, 33, 34, 36, 38, 39, 41, 44, 46, 47, 49, 55, 65, 67, 70, 71, 72, 76, 80, 82, 86, 89, 91, 97, 98, 100, 106, 120, 143, 144, 148, 150], "indic": [0, 3, 4, 17, 21, 25, 28, 33, 38, 42, 46, 52, 66, 70, 71, 72, 74, 76, 82, 86, 88, 91, 97, 98, 100, 108, 111, 142, 143], "letter": [0, 33, 46, 102], "them": [0, 3, 11, 21, 33, 43, 47, 52, 69, 74, 91, 113, 119, 120, 128, 131, 149, 154], "a_i": [0, 70], "multipli": [0, 3, 14, 15, 16, 27, 38, 41, 46, 49, 88, 91], "b_": [0, 11, 14, 45, 46, 52, 66, 82, 86, 91, 106, 113], "along": [0, 6, 11, 20, 28, 31, 38, 47, 60, 61, 64, 74, 82, 83, 88, 91, 92, 105, 113, 128, 131, 132, 139, 143, 150, 157], "hand": [0, 11, 18, 20, 21, 33, 43, 46, 49, 52, 55, 61, 72, 75, 82, 91, 122], "side": [0, 20, 21, 46, 47, 49, 60, 61, 65], "48": [0, 20, 76, 81, 86, 88, 90, 100, 101, 120, 122, 124, 125, 143, 156], "word": [0, 8, 16, 20, 22, 27, 71, 82, 88, 113], "repeat": [0, 33, 38, 55, 82, 91, 99, 153], "index": [0, 3, 25, 29, 33, 42, 47, 70, 74, 76, 81, 82, 86, 88, 89, 91, 94, 96, 100, 106, 113, 125, 142, 143, 144, 154, 156], "tell": [0, 43, 92, 101, 146], "dimens": [0, 3, 52, 71, 86, 94, 97, 106, 113, 133, 142, 148], "omit": [0, 25, 38], "simpler": [0, 3, 21, 46, 122, 143], "multipl": [0, 3, 20, 42, 46, 47, 70, 71, 75, 90, 94, 98, 101, 113, 120, 124, 125, 136, 143, 144, 148], "trace": [0, 38, 82, 84, 91, 153], "respect": [0, 3, 4, 6, 8, 12, 15, 16, 20, 21, 22, 24, 25, 26, 28, 31, 33, 36, 38, 41, 45, 46, 47, 48, 49, 50, 52, 55, 59, 60, 61, 66, 70, 71, 72, 73, 74, 76, 82, 83, 84, 88, 89, 91, 96, 97, 98, 100, 102, 103, 105, 111, 113, 117, 122, 130, 132, 133, 142, 143, 144, 150, 159], "integr": [0, 3, 5, 7, 9, 13, 19, 20, 21, 25, 29, 33, 39, 43, 46, 49, 53, 61, 67, 70, 71, 72, 75, 80, 82, 90, 99, 100, 101, 102, 113, 120, 124, 144], "would": [0, 3, 6, 14, 20, 21, 22, 45, 72, 75, 90, 101, 108, 120, 122, 125, 128, 132, 142, 143, 149, 153, 154, 156], "prefer": [0, 124], "kinet": [0, 16, 19, 20, 25, 39, 55, 70, 120, 125, 143, 148], "langl": [0, 3, 6, 11, 14, 15, 16, 20, 21, 22, 25, 26, 27, 28, 29, 30, 31, 33, 38, 39, 46, 49, 70, 71, 72, 75, 76, 78, 80, 82, 84, 86, 88, 89, 90, 91, 94, 96, 97, 98, 99, 100, 102, 111, 113, 122, 144, 146, 148, 150], "hat": [0, 3, 6, 7, 11, 15, 16, 19, 20, 21, 22, 25, 26, 27, 28, 29, 31, 33, 35, 38, 39, 46, 70, 72, 73, 75, 76, 78, 82, 84, 86, 88, 89, 90, 91, 94, 96, 97, 98, 99, 100, 102, 111, 113, 117, 122, 144, 146, 150], "t": [0, 1, 3, 7, 14, 16, 17, 19, 21, 22, 25, 26, 27, 28, 38, 39, 45, 46, 49, 52, 55, 60, 67, 70, 72, 74, 76, 78, 81, 82, 88, 89, 90, 91, 94, 97, 98, 99, 100, 106, 108, 111, 113, 122, 123, 143, 144, 148, 150, 153], "rangl": [0, 3, 6, 10, 11, 14, 15, 16, 19, 20, 21, 22, 25, 26, 27, 28, 29, 30, 31, 33, 38, 39, 46, 49, 70, 71, 72, 75, 76, 78, 80, 84, 86, 88, 89, 90, 91, 94, 96, 97, 98, 99, 100, 102, 105, 111, 113, 117, 122, 130, 144, 146, 148, 150], "sum_": [0, 3, 6, 7, 14, 15, 16, 17, 18, 19, 21, 22, 24, 25, 26, 27, 28, 29, 31, 33, 36, 38, 39, 41, 46, 49, 61, 66, 70, 71, 72, 73, 75, 78, 80, 82, 84, 86, 88, 89, 94, 96, 97, 99, 111, 117], "mathrm": [0, 3, 6, 7, 8, 10, 14, 15, 16, 17, 18, 19, 20, 21, 22, 24, 25, 26, 28, 29, 30, 35, 36, 38, 39, 40, 41, 45, 46, 47, 49, 52, 60, 61, 66, 70, 76, 78, 82, 86, 88, 90, 91, 94, 96, 97, 99, 100, 106, 111, 113, 122, 133, 150], "occ": [0, 17, 21, 22, 24, 25, 28, 29, 33, 70, 86, 88, 90, 94, 97, 111, 113, 142], "t_": [0, 19, 22, 33, 46, 70, 72, 82, 94], "ii": [0, 3, 7, 21, 24, 25, 29, 39, 46, 66, 67, 88, 89, 159], "info": [0, 20, 21, 42, 62, 70, 72, 76, 89, 98, 100, 120, 125, 143, 148], "opt": [0, 20, 21, 100, 120, 125, 143, 148], "miniconda3": [0, 20, 21, 100, 120, 125, 143, 148], "env": [0, 20, 21, 42, 100, 120, 125, 143, 148], "lib": [0, 20, 21, 100, 120, 125, 143, 148], "python3": [0, 20, 21, 100, 120, 125, 143, 148], "site": [0, 20, 21, 39, 100, 120, 125, 139, 142, 143, 148, 149, 159], "1p": [0, 20, 24, 70, 90, 101, 120, 122, 124, 125, 143, 148], "3p": [0, 120, 143, 144], "21": [0, 14, 20, 31, 43, 62, 67, 70, 71, 72, 89, 90, 92, 100, 101, 120, 122, 124, 125, 143, 144, 148, 149, 150, 156], "kin_drv": [0, 22, 25], "kineticenergyintegralsdriv": [0, 3, 7, 14, 17, 21, 22, 25, 39], "t_ao": [0, 22, 25], "to_numpi": [0, 3, 7, 14, 17, 21, 22, 25, 33, 39], "coeffici": [0, 3, 8, 9, 10, 13, 14, 17, 18, 21, 22, 25, 26, 33, 39, 46, 49, 72, 75, 76, 80, 96, 98, 99, 105, 113, 141, 144, 148, 150], "nocc": [0, 7, 10, 14, 17, 22, 25, 28, 38, 39, 70, 81, 86, 88, 94, 96, 106, 113, 115, 142, 143, 144], "number_of_alpha_electron": [0, 10, 14, 17, 22, 25, 28, 38, 39, 70, 81, 86, 88, 94, 96, 106, 113, 115, 142, 143, 144], "c_alpha": [0, 13, 17, 18, 24, 25, 26, 28, 33, 38, 70, 81, 86, 88, 96, 113, 144], "pq": [0, 3, 17, 21, 24, 28, 29, 33, 46, 49, 70, 72, 73, 75, 86, 88, 97, 111, 150], "p": [0, 1, 3, 6, 7, 11, 17, 18, 21, 24, 25, 26, 27, 28, 29, 30, 33, 38, 40, 46, 49, 60, 67, 70, 72, 76, 78, 82, 88, 89, 91, 96, 97, 98, 99, 100, 120, 133, 148, 150, 154], "q": [0, 3, 11, 17, 21, 24, 28, 29, 33, 36, 38, 40, 45, 46, 49, 52, 60, 66, 70, 72, 82, 84, 88, 91, 97, 100], "_": [0, 3, 4, 7, 11, 15, 17, 18, 20, 21, 22, 24, 25, 26, 27, 28, 29, 30, 31, 35, 38, 39, 40, 45, 46, 49, 55, 60, 62, 66, 70, 71, 72, 73, 75, 76, 78, 80, 82, 83, 84, 86, 88, 89, 90, 91, 94, 96, 97, 98, 100, 111, 113, 115, 117, 136, 143, 153], "c_": [0, 3, 7, 8, 15, 17, 19, 24, 26, 28, 33, 38, 39, 46, 49, 71, 80, 82, 91, 96, 106, 113, 144], "mathbf": [0, 3, 4, 6, 7, 8, 10, 14, 15, 16, 17, 18, 19, 21, 24, 25, 26, 28, 29, 30, 31, 36, 38, 39, 40, 45, 46, 49, 52, 55, 60, 61, 66, 70, 71, 72, 73, 74, 80, 82, 84, 86, 88, 91, 94, 97, 100, 106, 111, 113, 150, 153], "real": [0, 3, 10, 15, 43, 46, 47, 49, 55, 67, 76, 83, 86, 91, 94, 97, 98, 99, 113, 143, 144], "ignor": [0, 25, 26, 70, 73, 82, 144], "complex": [0, 3, 15, 20, 21, 31, 33, 35, 39, 43, 47, 53, 67, 76, 82, 83, 86, 97, 98, 99, 111, 124, 142, 143, 144, 147, 149, 159], "conjug": [0, 3, 15, 25, 46, 89, 97, 98, 99, 102, 111, 144], "know": [0, 3, 20, 61, 92, 122], "how": [0, 3, 4, 12, 18, 20, 21, 27, 43, 46, 47, 50, 51, 52, 53, 55, 56, 57, 61, 65, 68, 70, 73, 78, 82, 90, 91, 93, 96, 101, 102, 103, 121, 123, 125, 126, 131, 132, 137, 140, 141, 142, 143, 144, 146, 148, 151, 154, 155, 156], "slice": 0, "extract": [0, 21, 22, 33, 47, 70, 76, 113, 117, 124, 142, 144, 145, 156], "orbital_energi": [0, 113, 143, 144, 145], "e_alpha": [0, 13, 33, 70, 86, 113, 143, 144, 145], "20": [0, 10, 13, 14, 20, 24, 28, 33, 34, 36, 41, 43, 47, 60, 62, 65, 67, 70, 72, 86, 89, 90, 101, 105, 120, 122, 124, 125, 130, 131, 143, 144, 145, 148, 156], "24238972": 0, "26646064": 0, "61558541": 0, "45278475": 0, "39106556": 0, "60181634": 0, "73720765": 0, "To": [0, 3, 4, 10, 14, 16, 17, 18, 19, 21, 25, 27, 33, 36, 38, 39, 41, 45, 46, 49, 52, 65, 71, 72, 82, 96, 101, 106, 122, 124, 127, 130, 131, 132, 139, 144, 145, 146, 148, 150, 153, 154, 156, 159], "unoccupi": [0, 4, 15, 18, 22, 29, 31, 46, 72, 86, 94, 96, 111, 113, 115, 128, 141, 142, 143, 144, 149, 150], "splice": 0, "look": [0, 3, 20, 21, 33, 43, 47, 65, 70, 72, 75, 90, 113, 120, 122, 125, 126, 131, 133, 139, 143, 145, 148, 153, 157, 159], "guid": [0, 43, 67, 120, 128, 133, 149], "interchang": 0, "becom": [0, 3, 4, 8, 10, 11, 14, 15, 16, 18, 19, 20, 21, 24, 25, 26, 27, 28, 29, 33, 41, 46, 47, 52, 55, 60, 74, 76, 82, 83, 88, 92, 94, 97, 101, 102, 103, 120, 122, 142, 143, 144, 149], "t_mo": 0, "ap": [0, 17, 22, 24, 28, 38, 46, 67, 86, 88], "bq": [0, 17, 22, 24, 28, 38, 86, 88], "ab": [0, 3, 5, 6, 7, 8, 17, 18, 19, 22, 24, 25, 27, 28, 33, 38, 39, 46, 49, 52, 67, 68, 70, 72, 80, 81, 83, 86, 88, 96, 99, 106, 113, 120, 122, 125, 139, 142, 143, 150, 153], "t_exp": 0, "3f": [0, 3, 24, 33, 47, 70, 75, 83, 113, 124, 144, 150, 151], "579": [0, 90], "hermitian": [0, 15, 24, 46, 68, 70, 72, 86, 97, 111, 113], "linalg": [0, 3, 7, 10, 14, 21, 24, 27, 33, 38, 39, 52, 60, 70, 81, 86, 94, 97, 99, 106, 113, 115, 148, 153], "eigh": [0, 3, 7, 10, 14, 24, 27, 39, 70, 81, 115, 153], "pair": [0, 3, 21, 23, 29, 38, 47, 71, 72, 73, 86, 90, 92, 94, 101, 113, 120, 124, 139], "s_": [0, 24, 26, 46, 49, 61, 72, 82, 96, 105, 117, 144, 153], "chi_": [0, 6, 7, 17, 18, 26, 28, 36, 38, 41, 46, 49, 82, 91], "round": 0, "237": [0, 26, 65], "053": [0, 3], "472": 0, "25": [0, 10, 14, 18, 20, 24, 27, 28, 38, 47, 59, 60, 62, 65, 70, 76, 86, 89, 90, 91, 100, 101, 120, 122, 124, 125, 130, 131, 132, 133, 136, 137, 139, 142, 143, 154, 156, 159], "24": [0, 3, 7, 10, 13, 14, 17, 20, 24, 44, 62, 65, 76, 83, 89, 90, 91, 98, 101, 120, 124, 125, 133, 143, 156], "orthogon": [0, 7, 20, 21, 33, 46, 66, 70, 72, 80, 101, 120, 125, 143, 148], "diagon": [0, 3, 4, 12, 15, 21, 24, 27, 33, 38, 41, 43, 46, 50, 66, 69, 71, 72, 73, 75, 84, 86, 88, 89, 94, 97, 113, 115, 120, 130, 139, 148, 153, 156], "diag": [0, 22, 27, 38, 52, 70, 139, 153], "dagger": [0, 3, 10, 11, 14, 15, 17, 21, 24, 25, 26, 28, 29, 30, 33, 38, 46, 61, 66, 70, 71, 72, 73, 75, 80, 86, 88, 97, 111, 113, 144, 150, 153], "column": [0, 10, 11, 21, 66, 72, 94, 113], "345": 0, "42": [0, 20, 65, 67, 76, 81, 97, 100, 101, 120, 122, 124, 143, 148, 156], "886": 0, "093": 0, "331": 0, "926": [0, 120], "18": [0, 7, 14, 20, 24, 25, 27, 34, 36, 41, 62, 67, 72, 84, 90, 91, 101, 113, 115, 120, 122, 124, 125, 129, 131, 143, 148, 150, 156], "713": 0, "644": [0, 70], "209": [0, 120, 156], "695": 0, "279": [0, 67, 90, 124], "313": 0, "584": 0, "437": [0, 90], "564": 0, "145": [0, 3, 36, 67], "131": [0, 72, 113, 156], "426": 0, "52": [0, 20, 24, 70, 90, 94, 101, 120, 122, 143, 148, 156], "321": 0, "609": 0, "673": [0, 136], "27": [0, 14, 20, 24, 44, 62, 70, 75, 81, 90, 101, 102, 105, 106, 113, 115, 120, 122, 124, 125, 143, 144, 145, 148, 150, 151, 156], "602": [0, 144, 150], "798": 0, "matmul": [0, 7, 14, 21, 38, 52, 81, 86, 88, 99, 106, 113, 144, 148], "s_diag": 0, "verifi": [0, 3, 10, 39, 92, 113, 126], "ident": [0, 3, 6, 11, 15, 24, 25, 27, 28, 29, 33, 36, 38, 41, 46, 88, 97, 106, 113, 122, 126, 148], "len": [0, 2, 3, 7, 14, 29, 38, 47, 52, 62, 70, 81, 99, 106, 113, 124, 125, 130, 131, 132, 139, 142, 143, 144, 148, 151, 156], "abs_diff": 0, "absolut": [0, 4, 18, 33, 76, 120, 124, 125, 126, 139, 142, 143, 144, 146, 149], "4e": [0, 3, 20, 75, 90, 101, 120, 124], "7195e": 0, "15": [0, 7, 14, 17, 18, 20, 21, 25, 26, 28, 33, 62, 67, 70, 72, 75, 76, 82, 90, 99, 101, 113, 120, 123, 124, 125, 130, 131, 132, 143, 144, 148, 150, 156, 157, 159], "item": 0, "arrang": [0, 38, 82], "kei": [0, 2, 5, 13, 22, 45, 46, 58, 76, 89, 98, 100, 108, 113, 131, 150], "some_dict": 0, "fruit": [0, 43], "appl": 0, "nprint": 0, "dict_kei": [0, 13, 58, 100, 113], "dict_valu": 0, "green": [0, 18, 73, 105], "fresh": 0, "ripe": 0, "width": [0, 18, 31, 39, 47, 59, 62, 65, 70, 73, 90, 92, 99, 100, 106, 120, 124, 130, 131, 132, 133, 136, 137, 139, 144, 154, 156, 157, 159], "height": [0, 18, 39, 47, 59, 62, 65, 67, 70, 90, 92, 124, 130, 131, 132, 133, 136, 137, 139, 154, 156, 157, 159], "check": [0, 3, 21, 33, 42, 50, 52, 60, 62, 72, 92, 133, 144], "str": [0, 8, 18, 20, 21, 29, 33, 47, 52, 72, 92, 105, 113, 120, 124, 125, 142, 144, 145, 148, 151, 153], "int": [0, 6, 15, 16, 18, 19, 20, 25, 28, 29, 30, 36, 40, 46, 49, 66, 67, 91, 94, 106, 148, 150], "fals": [0, 10, 14, 27, 33, 39, 52, 62, 65, 70, 72, 94, 105, 122, 131, 133, 136, 139, 153, 157, 159], "certain": [0, 82, 128, 143, 144, 149], "compos": [0, 11, 16, 27, 60, 66, 74, 82], "angl": [0, 4, 8, 11, 45, 52, 53, 58, 82, 100, 130, 142, 150], "radian": 0, "degre": [0, 4, 26, 45, 52, 58, 66, 129, 147], "2f": [0, 7, 21, 33, 44, 65, 70, 99, 105, 131, 144, 156], "45": [0, 20, 24, 39, 61, 67, 70, 76, 81, 90, 100, 101, 120, 122, 124, 125, 131, 143, 148, 150, 156, 157], "785": [0, 67], "chosen": [0, 3, 7, 8, 27, 34, 38, 49, 55, 82, 83, 84, 91, 96, 122, 124, 133, 144], "high": [0, 20, 38, 41, 42, 43, 55, 67, 75, 101, 106, 120, 124, 128, 130, 136, 142, 143, 144, 148, 149], "interfac": [0, 43, 59, 133], "layer": [0, 18, 36, 41, 43], "account": [0, 4, 8, 19, 33, 35, 40, 46, 47, 60, 61, 69, 71, 72, 76, 82, 89, 136, 143, 144, 149, 150], "its": [0, 3, 5, 9, 11, 15, 16, 19, 21, 22, 26, 33, 39, 43, 45, 46, 47, 49, 52, 55, 60, 61, 69, 71, 73, 74, 82, 84, 88, 89, 91, 98, 100, 101, 103, 113, 122, 124, 144, 149, 154, 156], "eas": [0, 43, 83, 142, 148], "framework": [0, 11, 20, 43, 67, 101, 143, 144], "intermingl": 0, "unfamiliar": 0, "wealth": [0, 54], "resourc": [0, 55, 133], "accomod": 0, "w3school": 0, "host": 0, "comprehens": [0, 43], "project": [0, 17, 27, 31, 42, 43, 60, 66, 130, 133, 144], "test": [0, 3, 17, 28, 33, 82, 86, 106], "page": [0, 3, 13, 43, 67, 68, 102], "prepar": [0, 60, 124, 132, 142, 144, 148, 151], "lesson": 0, "video": 0, "document": [0, 43, 80], "galleri": 0, "dedic": 0, "teach": [0, 1, 43, 148], "chemist": [0, 17, 22, 25, 29, 70, 78, 150], "jupyterhub": 0, "serv": [0, 12, 17, 43, 52, 78, 103, 143], "instruct": [0, 88], "deploi": 0, "cloud": 0, "seaborn": 0, "publish": [1, 91], "creativ": 1, "common": [1, 3, 10, 15, 22, 24, 25, 31, 47, 64, 82, 84, 105, 122, 133, 141, 143, 145, 153], "sharealik": 1, "licens": 1, "cc": [1, 2, 4, 6, 7, 8, 10, 13, 14, 17, 18, 20, 22, 24, 25, 26, 28, 33, 39, 44, 58, 59, 72, 78, 92, 106, 113, 120, 122, 128, 133, 143, 144, 149, 157], "BY": 1, "sa": [1, 90, 92, 101, 124], "fransson": [1, 67], "delcei": 1, "brumboiu": [1, 67], "hodeck": [1, 67], "li": [1, 46, 67, 70, 72, 82, 83], "rinkeviciu": [1, 67], "z": [1, 6, 8, 11, 17, 18, 20, 21, 28, 31, 33, 38, 45, 49, 52, 60, 61, 67, 70, 75, 76, 78, 82, 83, 84, 86, 88, 89, 90, 91, 96, 98, 101, 105, 111, 113, 120, 124, 131, 142, 143, 144, 146, 148, 149, 150, 151, 156, 157], "dreuw": [1, 67, 70], "rhee": [1, 67], "norman": [1, 67], "laptop": [1, 43, 147], "hpc": [1, 17, 42, 43, 68], "notebook": [1, 13, 38, 43, 47, 102, 119, 137, 140, 153, 154, 156, 157], "explor": [1, 9, 18, 43, 56, 65, 119], "kth": 1, "royal": [1, 67], "institut": 1, "technologi": 1, "stockholm": 1, "2022": [1, 67, 156], "doi": [1, 67], "30746": 1, "978": [1, 67, 90, 101, 124], "91": [1, 20, 67, 76, 100, 120, 143, 156], "988114": 1, "us": [1, 2, 3, 4, 5, 6, 7, 9, 10, 11, 12, 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, 25, 26, 27, 28, 29, 35, 36, 37, 38, 39, 42, 43, 44, 45, 46, 47, 48, 49, 51, 52, 53, 54, 55, 57, 58, 59, 60, 61, 62, 64, 65, 66, 67, 69, 70, 72, 73, 74, 75, 76, 78, 82, 83, 84, 86, 88, 89, 90, 91, 92, 93, 94, 96, 97, 98, 99, 100, 101, 102, 104, 105, 108, 109, 111, 113, 117, 118, 120, 122, 123, 124, 125, 126, 128, 131, 132, 136, 137, 139, 140, 141, 142, 143, 144, 145, 146, 147, 148, 149, 150, 152, 153, 154, 156, 159], "articl": [1, 67, 153], "didact": 1, "aspect": [1, 18, 22, 49, 68, 72, 74, 104, 113, 129, 136, 141, 147], "chem": [1, 34, 36, 41, 67, 70, 76, 89, 98, 148], "educ": [1, 43], "1664": [1, 156], "1671": [1, 156], "2023": [1, 156], "1021": [1, 67, 156], "ac": [1, 46, 67, 72, 76], "jcheme": 1, "2c01103": 1, "appreci": [1, 143], "suggest": [1, 3, 20, 21, 43, 72, 123, 128, 148, 149], "materi": [1, 67, 69, 82, 91], "present": [1, 9, 14, 18, 20, 23, 32, 35, 36, 43, 59, 69, 102, 103, 105, 108, 130, 133, 136, 143, 148, 149], "hesit": 1, "reach": [1, 3, 5, 7, 14, 18, 19, 20, 21, 38, 57, 60, 69, 72, 75, 90, 96, 97, 101, 105, 120, 122, 124], "author": [1, 82, 128, 136, 149, 150], "open": [1, 11, 13, 20, 24, 39, 42, 62, 70, 92, 122, 132, 133, 139, 148, 154, 156, 157], "github": [1, 42, 43], "section": [1, 3, 5, 9, 12, 20, 21, 22, 23, 30, 32, 33, 35, 37, 39, 40, 43, 46, 48, 49, 51, 54, 55, 56, 57, 60, 61, 63, 66, 67, 69, 70, 72, 75, 82, 91, 93, 94, 101, 103, 105, 117, 122, 123, 124, 125, 129, 130, 131, 133, 137, 139, 140, 142, 143, 144, 147, 148, 150, 151, 153, 154, 155, 156], "miss": [1, 143], "contribut": [1, 3, 8, 19, 21, 24, 33, 38, 39, 40, 46, 49, 61, 65, 72, 74, 80, 84, 88, 89, 90, 96, 103, 113, 133, 141, 143], "exchang": [2, 3, 5, 6, 7, 15, 18, 25, 26, 31, 33, 46, 47, 49, 67, 73, 76, 80, 89, 98, 105, 111, 117, 137, 143, 144, 148, 149], "correl": [2, 3, 5, 6, 7, 9, 17, 18, 23, 33, 43, 46, 49, 67, 69, 72, 75, 76, 80, 92, 98, 101, 105, 121, 122, 124, 128, 136, 137, 143, 144, 147, 148, 149], "calcul": [2, 3, 5, 9, 17, 18, 19, 20, 21, 22, 24, 28, 34, 36, 37, 40, 41, 43, 46, 47, 48, 49, 50, 51, 52, 55, 59, 60, 61, 62, 66, 67, 68, 71, 76, 78, 80, 82, 84, 88, 89, 92, 96, 98, 99, 100, 101, 104, 105, 106, 108, 109, 111, 113, 117, 120, 122, 123, 124, 125, 128, 129, 130, 131, 134, 137, 139, 141, 142, 143, 145, 146, 147, 149, 152, 153, 156, 157], "electron": [2, 5, 6, 7, 8, 9, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 24, 27, 28, 33, 36, 38, 39, 40, 43, 44, 45, 46, 47, 49, 58, 59, 61, 65, 67, 68, 69, 70, 72, 73, 74, 76, 78, 80, 82, 83, 90, 91, 94, 96, 98, 100, 101, 102, 103, 105, 106, 111, 115, 120, 122, 123, 124, 125, 129, 130, 132, 136, 140, 141, 143, 144, 148], "helium": [2, 4, 8, 67, 76], "hf": [2, 3, 4, 7, 8, 12, 14, 15, 20, 21, 22, 24, 50, 52, 70, 75, 80, 90, 92, 97, 105, 106, 113, 120, 131, 132, 137, 142, 144, 145, 146, 149, 156], "second": [2, 3, 4, 7, 8, 9, 17, 19, 21, 22, 26, 32, 33, 34, 36, 40, 41, 45, 46, 47, 50, 52, 55, 60, 61, 64, 66, 67, 72, 73, 74, 75, 82, 83, 84, 88, 89, 91, 98, 100, 101, 111, 113, 115, 117, 120, 122, 130, 141, 148, 149, 150], "m\u00f8ller": [2, 9, 17, 32, 43, 46, 68, 70, 73], "plesset": [2, 9, 17, 32, 43, 46, 68, 70, 73], "configur": [2, 4, 20, 21, 24, 25, 32, 38, 39, 42, 43, 46, 47, 52, 67, 69, 72, 90, 97, 101, 102, 105, 115, 118, 120, 122, 124, 125, 128, 131, 143, 148, 149, 154, 156], "kohn": [2, 5, 6, 7, 12, 20, 40, 43, 46, 49, 67, 100, 108, 111, 122, 137, 148], "sham": [2, 5, 6, 7, 12, 20, 40, 43, 46, 49, 67, 100, 108, 111, 122, 137, 148], "theori": [2, 4, 7, 9, 12, 16, 17, 19, 22, 23, 28, 33, 34, 36, 38, 41, 43, 44, 46, 47, 49, 50, 52, 56, 58, 59, 65, 67, 68, 69, 70, 72, 73, 76, 80, 88, 90, 93, 96, 98, 99, 102, 103, 104, 105, 108, 109, 113, 124, 128, 132, 137, 139, 141, 143, 144, 145, 148, 149, 153], "multipsi": [2, 3, 4, 17, 20, 21, 22, 24, 33, 43, 75, 90, 92, 101, 120, 122, 124, 144, 157], "mtp": [2, 3, 4, 20, 21, 22, 24, 33, 75, 90, 92, 101, 120, 122, 124, 144, 157], "read_molecule_str": [2, 4, 20, 21, 28, 33, 38, 47, 52, 92, 100, 106, 120, 122, 124, 142, 143, 145, 148, 157], "he": [2, 4, 8, 18, 67, 89], "000": [2, 3, 20, 24, 70, 78, 90, 101, 120, 122, 124, 125, 130, 143, 148, 150], "basi": [2, 6, 7, 9, 12, 13, 17, 18, 20, 21, 24, 25, 28, 30, 33, 34, 36, 38, 39, 41, 43, 46, 47, 49, 52, 61, 65, 67, 70, 72, 75, 76, 78, 83, 86, 88, 90, 91, 92, 94, 96, 97, 98, 99, 100, 101, 102, 105, 106, 113, 115, 117, 120, 122, 124, 125, 126, 130, 131, 132, 136, 137, 139, 141, 142, 144, 145, 148, 151, 153, 157], "pvtz": [2, 4, 8, 26, 143, 144, 149], "mp2_drv": [2, 8, 22], "mp2driver": [2, 8, 22, 33, 144], "mp2_result": [2, 8, 22], "mp2_energi": [2, 8, 22], "orbspac": [2, 3, 4, 20, 21, 22, 24, 33, 75, 90, 101, 120, 122, 124, 144], "ci_drv": [2, 3, 4, 22, 33, 120], "cidriv": [2, 3, 4, 20, 21, 22, 33, 75, 101, 120], "ci_result": [2, 3, 4, 20, 21, 22, 33, 75, 101, 120], "get_energi": [2, 3, 4, 20, 21, 22, 24, 92, 101, 120, 122], "xcfun": [2, 6, 7, 18, 20, 47, 65, 76, 83, 89, 94, 98, 100, 102, 105, 106, 115, 122, 124, 136, 137, 142, 144, 148, 151, 153], "available_funct": 2, "16": [2, 3, 7, 14, 18, 20, 21, 22, 24, 39, 62, 67, 70, 72, 76, 78, 83, 90, 94, 101, 105, 120, 122, 123, 124, 125, 143, 144, 156], "8f": [2, 4, 6, 7, 14, 18, 21, 22, 24, 27, 39, 86, 88, 122], "86115334": 2, "89429091": 2, "90023217": 2, "slater": [2, 3, 7, 11, 12, 15, 19, 20, 21, 28, 33, 38, 46, 80, 108, 111, 122, 143, 149, 150], "72271178": 2, "slda": 2, "87143717": 2, "b88x": 2, "86247050": 2, "blyp": [2, 20, 126], "90621759": 2, "b3lyp": [2, 6, 18, 19, 47, 62, 65, 67, 76, 83, 89, 98, 100, 105, 106, 115, 122, 124, 126, 128, 136, 137, 142, 143, 144, 146, 148, 149, 151, 153], "91450655": 2, "bhandh": 2, "83473781": 2, "bhandhlyp": [2, 94, 102, 105, 126], "90514866": 2, "pbe": [2, 19, 143], "89213590": 2, "pbe0": 2, "89451563": 2, "revpb": 2, "90710482": 2, "bp86": 2, "90557480": 2, "pw91": 2, "89919908": 2, "mpw1k": 2, "90521521": 2, "olyp": 2, "90644600": 2, "o3lyp": 2, "90951647": 2, "x3lyp": 2, "90758515": 2, "b97": 2, "90931588": 2, "90639481": 2, "90940855": 2, "91133188": 2, "tpss": [2, 19], "90886838": 2, "tpssh": 2, "90836089": 2, "revtpss": 2, "91132827": 2, "pkzb": 2, "90387499": 2, "scan": [2, 20, 21, 47, 62, 64, 92, 100, 120], "90431544": 2, "rscan": 2, "r2scan": 2, "m05": 2, "90471113": 2, "2x": 2, "90804370": 2, "m06": [2, 19, 67], "90925996": 2, "90399052": 2, "90187434": 2, "91319059": 2, "m11": 2, "91833797": 2, "mpw1b95": 2, "90141905": 2, "mpwb1k": 2, "90163660": 2, "pw6b95": 2, "91673962": 2, "pwb6k": 2, "90888490": 2, "fig": [2, 7, 18, 20, 28, 58, 59, 60, 65, 69, 96, 99, 100, 113, 123, 124, 129, 157], "ax": [2, 7, 11, 18, 20, 31, 46, 58, 59, 60, 66, 67, 74, 76, 82, 88, 96, 98, 99, 100, 150], "subplot": [2, 3, 20, 28, 58, 59, 62, 99, 100, 113, 124, 142, 143, 144, 151], "enumer": [2, 3, 24, 33, 38, 39, 44, 81, 83, 105, 122], "set_xtick": [2, 18], "rang": [2, 3, 4, 7, 12, 14, 18, 20, 21, 22, 24, 27, 28, 29, 31, 33, 35, 38, 39, 43, 52, 62, 67, 70, 75, 76, 81, 86, 88, 92, 97, 99, 100, 101, 106, 113, 120, 124, 125, 128, 130, 131, 132, 136, 143, 144, 148, 149, 151, 156], "xtick": [2, 3, 4, 7, 27, 31, 75, 96, 101, 113, 143], "90": [2, 20, 47, 62, 70, 90, 92, 120, 130, 132, 143, 150, 156, 159], "set_ylim": [2, 20, 100], "93": [2, 20, 67, 100, 101, 120, 143, 144, 156], "82": [2, 3, 20, 67, 101, 122, 143, 156], "conceptu": 3, "computation": [3, 5, 38, 47, 72, 144, 149], "simplest": [3, 21, 46, 55, 60, 89, 129], "solv": [3, 14, 15, 16, 25, 33, 38, 41, 43, 45, 46, 47, 49, 71, 75, 100, 106, 108, 111, 113, 120, 148, 150], "schr\u00f6dinger": [3, 9, 16, 22, 25, 47, 108, 150], "simpli": [3, 20, 43, 47, 49, 61, 66, 70, 75, 91, 99, 101, 120, 124, 131, 133, 153], "expand": [3, 15, 21, 22, 24, 26, 27, 30, 46, 49, 70, 71, 72, 73, 86, 88, 89, 91, 96, 100, 108, 111, 122], "mani": [3, 6, 9, 11, 12, 15, 17, 19, 21, 27, 33, 43, 46, 47, 53, 60, 67, 70, 72, 73, 92, 98, 101, 106, 133, 142, 143, 144, 149, 153], "bodi": [3, 21, 53, 67, 72, 73, 144], "wave": [3, 4, 6, 9, 12, 13, 15, 16, 17, 20, 22, 24, 25, 27, 29, 31, 33, 39, 43, 46, 67, 70, 72, 75, 76, 80, 82, 84, 86, 88, 90, 96, 97, 99, 100, 102, 103, 111, 117, 120, 122, 125, 128, 144, 148, 149], "function": [3, 4, 6, 7, 8, 9, 10, 12, 13, 14, 15, 16, 17, 21, 22, 23, 24, 25, 27, 28, 29, 31, 33, 39, 41, 42, 43, 46, 47, 49, 54, 55, 60, 62, 65, 67, 70, 72, 73, 75, 76, 78, 80, 81, 82, 83, 84, 90, 91, 94, 96, 97, 98, 100, 102, 103, 104, 105, 108, 111, 113, 117, 120, 122, 124, 125, 128, 130, 131, 133, 137, 139, 142, 144, 145, 146, 148, 149, 152, 154, 156, 157, 159], "set": [3, 9, 11, 12, 13, 15, 16, 17, 18, 20, 21, 22, 24, 25, 27, 29, 30, 31, 33, 36, 38, 40, 42, 43, 45, 46, 47, 49, 51, 52, 55, 60, 61, 66, 67, 70, 72, 74, 75, 78, 82, 83, 90, 91, 92, 96, 98, 100, 101, 103, 106, 111, 113, 115, 117, 120, 122, 124, 125, 126, 130, 131, 132, 136, 137, 139, 141, 142, 144, 145, 148, 151, 153, 154, 157], "psi_": [3, 11, 15, 19, 20, 21, 22, 25, 26, 27, 28, 29, 30, 31, 80, 97, 100, 122], "sum_k": [3, 16, 25, 46, 82], "c_k": 3, "k": [3, 4, 7, 10, 14, 15, 16, 17, 19, 20, 22, 25, 27, 29, 31, 33, 39, 44, 46, 47, 60, 61, 65, 66, 67, 69, 70, 71, 72, 81, 82, 84, 89, 99, 100, 106, 120, 124, 125, 130, 132, 141, 142, 143, 144, 148, 149, 150, 151, 153], "energi": [3, 7, 9, 10, 12, 13, 16, 19, 20, 21, 24, 25, 31, 35, 43, 44, 45, 47, 48, 49, 50, 51, 55, 56, 57, 58, 59, 60, 61, 62, 64, 66, 67, 69, 70, 71, 73, 75, 76, 78, 84, 88, 89, 90, 91, 92, 96, 98, 99, 100, 101, 102, 104, 105, 106, 108, 111, 115, 117, 120, 122, 123, 124, 125, 126, 129, 130, 134, 137, 141, 142, 143, 144, 145, 146, 149, 150, 151, 153, 156], "e_": [3, 4, 7, 8, 15, 18, 19, 22, 27, 35, 39, 40, 46, 47, 49, 82, 91, 100, 143, 150], "There": [3, 5, 11, 20, 29, 36, 46, 60, 75, 88, 92, 94, 122, 124, 144], "redund": [3, 45, 60, 67, 90], "constant": [3, 16, 38, 47, 50, 55, 60, 73, 76, 89, 91, 99, 100, 143, 144, 150, 156], "doe": [3, 4, 11, 14, 16, 21, 30, 42, 47, 55, 65, 72, 74, 75, 84, 89, 92, 97, 98, 99, 121, 122, 126, 128, 131, 142, 143, 144, 146, 148, 149, 153], "thu": [3, 15, 20, 21, 22, 28, 29, 33, 39, 40, 42, 46, 47, 53, 61, 66, 69, 72, 73, 75, 76, 82, 83, 89, 90, 91, 92, 98, 101, 102, 113, 120, 122, 123, 124, 128, 130, 133, 139, 141, 142, 143, 144, 147, 148, 149, 153, 157], "normal": [3, 22, 26, 27, 31, 33, 38, 43, 46, 47, 50, 52, 61, 66, 86, 88, 89, 111, 113, 130, 131, 132, 144, 151], "lagrangian": [3, 14, 16, 34, 36, 38, 46, 61, 67], "epsilon": [3, 7, 10, 14, 33, 39, 47, 86, 89, 99, 100], "gradient": [3, 20, 21, 33, 38, 43, 45, 47, 49, 50, 52, 57, 64, 66, 67, 70, 82, 90, 101, 106, 111, 120, 124, 125, 129, 130, 131, 132, 143, 148, 150], "sum_i": [3, 16, 19, 21, 28, 29, 30, 40, 46, 52, 70, 80, 84, 90, 91, 111, 144], "denot": [3, 11, 25, 26, 29, 33, 45, 46, 60, 66, 72, 80, 82, 83, 102, 113, 150], "express": [3, 6, 8, 10, 15, 19, 20, 21, 24, 25, 26, 28, 30, 31, 33, 38, 43, 45, 46, 47, 55, 61, 70, 71, 73, 76, 80, 82, 84, 88, 89, 91, 99, 100, 108, 109, 111, 117, 124, 139, 150], "recast": 3, "equival": [3, 8, 11, 17, 20, 21, 28, 33, 36, 38, 41, 46, 49, 72, 91, 100, 120, 122, 141, 143, 150], "eigenvalu": [3, 15, 45, 46, 52, 60, 64, 65, 66, 70, 72, 90, 99, 102, 105, 106, 113, 115, 122, 124, 130, 132, 144, 148, 151, 153], "possibl": [3, 4, 5, 8, 11, 16, 29, 33, 38, 43, 47, 50, 53, 55, 70, 72, 73, 83, 91, 99, 109, 111, 123, 124, 128, 133, 144, 148, 150, 157], "state": [3, 5, 6, 7, 10, 12, 13, 15, 16, 18, 19, 20, 21, 24, 25, 26, 27, 28, 31, 34, 36, 41, 43, 45, 48, 49, 51, 55, 56, 60, 67, 68, 69, 73, 74, 75, 76, 78, 81, 82, 86, 88, 89, 90, 91, 92, 93, 94, 96, 98, 99, 102, 103, 104, 105, 106, 108, 111, 113, 115, 117, 118, 120, 121, 123, 124, 125, 128, 129, 130, 131, 132, 136, 141, 142, 143, 147, 149, 150, 151, 158], "ground": [3, 10, 13, 15, 16, 18, 19, 20, 21, 22, 27, 33, 43, 49, 51, 65, 67, 70, 72, 73, 75, 78, 80, 89, 90, 92, 99, 100, 101, 102, 108, 120, 122, 123, 124, 125, 129, 130, 131, 136, 143, 147, 148, 150], "correspond": [3, 7, 14, 17, 20, 21, 22, 27, 29, 33, 38, 39, 45, 46, 47, 49, 52, 55, 60, 61, 66, 67, 69, 70, 71, 72, 73, 74, 75, 76, 82, 84, 89, 90, 91, 92, 98, 100, 101, 108, 111, 113, 115, 120, 122, 124, 130, 133, 136, 139, 142, 149, 153, 156], "lowest": [3, 15, 18, 21, 31, 33, 44, 72, 75, 90, 91, 92, 97, 100, 102, 113, 115, 122, 124, 125, 142, 144, 145, 153], "principl": [3, 5, 14, 16, 67, 72, 82, 99, 101, 111, 113, 122, 124, 133, 147], "infinit": [3, 15, 16, 20, 46], "choos": [3, 13, 20, 27, 43, 46, 80, 82, 144, 145, 150], "ideal": [3, 20, 101, 150], "expans": [3, 20, 21, 26, 33, 38, 47, 49, 52, 55, 70, 72, 73, 75, 76, 82, 84, 90, 91, 96, 98, 99, 100, 101, 111, 120, 124], "quickli": [3, 47], "compact": [3, 15, 72, 82, 86, 94, 125, 141, 143, 153], "easili": [3, 20, 27, 46, 47, 52, 55, 60, 72, 82, 106, 120, 142, 144], "manipul": [3, 21, 29, 62, 157], "effici": [3, 33, 43, 46, 47, 49, 67, 89, 91, 103], "unfortun": [3, 71], "criteria": [3, 19, 55], "oppos": [3, 47], "explicitli": [3, 17, 19, 22, 40, 46, 76, 91, 96, 98, 113, 143, 144], "gaussian": [3, 46, 70, 130, 131, 132, 156], "nuclei": [3, 4, 25, 31, 36, 39, 40, 47, 55, 144, 150], "interelectron": 3, "veri": [3, 4, 6, 8, 18, 20, 21, 33, 43, 45, 46, 47, 52, 53, 59, 60, 62, 69, 70, 72, 82, 89, 99, 101, 111, 113, 120, 122, 123, 128, 139, 141, 142, 143, 144, 149], "difficult": [3, 16, 46, 47, 55, 143], "coupl": [3, 15, 21, 27, 45, 46, 47, 49, 50, 55, 61, 67, 72, 78, 81, 88, 99, 102, 103, 106, 111, 117, 128, 141, 144, 149, 150], "explicit": [3, 4, 5, 10, 14, 20, 21, 29, 46, 49, 68, 70, 71, 73, 75, 83, 91, 103, 113, 120, 142, 143, 144, 148], "product": [3, 4, 11, 20, 25, 26, 28, 33, 61, 80, 82, 91, 92, 99, 100, 102, 136, 145], "sinc": [3, 5, 6, 11, 15, 17, 19, 20, 21, 25, 27, 34, 46, 49, 55, 61, 65, 66, 71, 72, 74, 76, 82, 83, 84, 90, 92, 97, 98, 101, 120, 122, 124, 133, 144, 153], "antisymmetr": [3, 80], "antisymmetris": 3, "version": [3, 14, 18, 42, 46, 55, 76, 89, 98, 142, 145, 148], "determin": [3, 4, 6, 7, 8, 10, 11, 12, 14, 15, 16, 18, 19, 20, 21, 22, 24, 27, 28, 33, 34, 35, 36, 38, 39, 40, 41, 43, 45, 46, 47, 49, 52, 55, 57, 60, 61, 65, 66, 67, 70, 72, 73, 75, 76, 80, 82, 83, 88, 89, 90, 91, 96, 98, 100, 101, 102, 105, 108, 111, 113, 120, 121, 122, 124, 128, 130, 132, 144, 149, 150, 153, 156], "sd": [3, 33, 71, 72], "result": [3, 4, 6, 7, 11, 12, 13, 15, 17, 18, 19, 20, 21, 22, 25, 26, 27, 28, 29, 31, 33, 34, 35, 36, 39, 41, 42, 43, 45, 46, 47, 52, 55, 59, 60, 62, 69, 71, 72, 74, 75, 76, 78, 82, 84, 86, 88, 90, 91, 92, 97, 98, 99, 100, 101, 102, 113, 115, 120, 122, 123, 124, 125, 126, 128, 133, 136, 137, 139, 142, 143, 144, 146, 147, 149, 153, 156, 157], "constitut": [3, 89, 130], "code": [3, 21, 33, 43, 46, 52, 59, 90, 91, 101, 105, 122, 147], "csf": 3, "fix": [3, 4, 20, 21, 25, 46, 47, 55, 62, 74, 82, 90, 92, 100, 108, 124], "linear": [3, 12, 14, 15, 20, 21, 28, 29, 31, 38, 43, 45, 46, 49, 61, 66, 67, 70, 72, 76, 78, 83, 84, 88, 91, 93, 96, 97, 98, 99, 102, 104, 111, 113, 117, 120, 124, 125, 129, 130, 131, 141, 143, 144, 148], "combin": [3, 6, 11, 15, 19, 21, 28, 31, 46, 47, 60, 61, 64, 66, 72, 78, 82, 88, 90, 91, 102, 140, 144, 149, 153], "attract": [3, 5, 8, 16, 21, 25, 39, 47, 69, 143, 144], "eigenfunct": [3, 15, 26, 31, 100, 122], "adapt": [3, 31, 38, 60, 69, 73, 97, 146], "less": [3, 7, 14, 18, 21, 66, 76, 83, 105, 108, 128, 149], "numer": [3, 5, 7, 14, 18, 22, 43, 48, 50, 52, 55, 61, 66, 67, 73, 82, 84, 89, 130, 132, 150], "than": [3, 4, 7, 11, 20, 21, 22, 25, 27, 30, 33, 39, 42, 43, 46, 47, 49, 52, 60, 61, 65, 72, 75, 80, 82, 84, 89, 90, 91, 96, 98, 101, 105, 108, 120, 122, 123, 124, 129, 139, 143, 144, 149, 153], "ha": [3, 5, 7, 8, 11, 13, 15, 19, 20, 21, 22, 25, 27, 29, 33, 38, 42, 43, 45, 46, 47, 50, 59, 60, 61, 64, 70, 71, 72, 74, 75, 76, 80, 82, 88, 89, 90, 92, 96, 98, 101, 102, 105, 106, 108, 111, 113, 115, 117, 120, 123, 124, 129, 136, 139, 142, 143, 144, 148, 149, 153], "standpoint": 3, "howev": [3, 6, 16, 17, 18, 20, 21, 24, 25, 33, 45, 46, 49, 55, 60, 61, 72, 75, 84, 89, 98, 99, 100, 101, 102, 103, 111, 117, 120, 122, 124, 128, 143, 144, 148, 149, 150], "allow": [3, 5, 16, 21, 22, 38, 41, 43, 45, 47, 52, 66, 68, 69, 70, 76, 82, 89, 91, 92, 99, 100, 102, 122, 141, 148, 149, 154], "outweigh": 3, "benefit": [3, 43], "slightli": [3, 21, 65, 111, 122, 149], "now": [3, 5, 10, 20, 21, 22, 25, 33, 42, 43, 45, 46, 47, 49, 52, 55, 60, 62, 65, 66, 70, 73, 75, 83, 90, 92, 100, 101, 106, 111, 113, 122, 125, 130, 131, 136, 139, 142, 144, 148, 153, 154, 156], "occup": [3, 7, 9, 20, 21, 24, 29, 33, 70, 75, 90, 101, 120, 122, 124, 125, 143, 145, 148, 150], "both": [3, 4, 8, 10, 17, 19, 20, 21, 24, 28, 29, 31, 33, 38, 43, 46, 47, 49, 55, 60, 69, 70, 72, 74, 75, 76, 78, 82, 84, 88, 90, 91, 92, 94, 111, 113, 120, 125, 130, 131, 132, 133, 136, 141, 143, 144, 148, 149, 152, 156], "match": [3, 20, 22, 33, 52, 101, 122, 129], "choic": [3, 10, 14, 18, 21, 27, 34, 38, 43, 47, 56, 58, 60, 78, 82, 84, 88, 128, 133], "lexic": 3, "revers": [3, 11, 17, 20, 21, 81, 91, 92, 94], "beyond": [3, 21, 33, 43, 53, 67, 143, 144, 149], "scope": [3, 21, 143, 149], "fortun": [3, 16, 71], "_2": [3, 4, 8, 11, 16, 20, 22, 25, 28, 30, 38, 66, 97, 120, 122, 123, 132, 136, 142, 143, 144, 146, 150, 153], "fock": [3, 4, 5, 6, 8, 13, 14, 19, 20, 21, 24, 25, 27, 28, 32, 34, 36, 38, 39, 41, 43, 46, 49, 50, 70, 71, 72, 76, 80, 88, 89, 92, 96, 97, 98, 100, 104, 105, 108, 111, 113, 120, 121, 122, 125, 136, 137, 143, 148, 150], "triplet": [3, 20, 31, 70, 122, 123, 136, 148], "unrestrict": [3, 9, 120, 121, 136, 137, 143, 144, 145, 148], "actual": [3, 20, 33, 43, 47, 49, 75, 90, 101, 122, 148], "could": [3, 20, 21, 43, 124, 143, 144, 147, 148], "singlet": [3, 20, 31, 70, 97, 122, 123, 124, 125, 142, 144, 145, 148, 153], "without": [3, 21, 27, 33, 42, 69, 73, 76, 82, 98, 101, 143, 144, 159], "np": [3, 4, 6, 7, 8, 10, 14, 17, 18, 20, 21, 22, 24, 25, 26, 27, 28, 29, 31, 33, 38, 39, 44, 47, 52, 58, 60, 62, 65, 70, 72, 75, 78, 81, 83, 86, 88, 92, 94, 96, 97, 99, 100, 101, 105, 106, 113, 115, 120, 124, 125, 130, 131, 132, 136, 139, 142, 143, 144, 145, 148, 151, 153, 156, 157], "o2_xyz": [3, 33], "600000000000": [3, 33], "000000000000": [3, 6, 7, 8, 10, 14, 17, 18, 21, 22, 33, 52, 72, 76, 83, 86, 89, 98], "set_multipl": [3, 20, 21, 24, 33, 120, 122, 136, 143, 144], "jupyt": [3, 4, 6, 7, 11, 13, 14, 18, 22, 24, 25, 26, 34, 36, 39, 41, 42, 43, 44, 47, 52, 58, 59, 62, 65, 70, 72, 75, 81, 88, 90, 92, 101, 102, 105, 113, 115, 124, 130, 131, 132, 133, 136, 137, 139, 140, 142, 143, 144, 151, 153, 154, 156, 157, 159], "scfunrestricteddriv": [3, 20, 21, 24, 33, 120, 122, 136, 143, 144], "fci": [3, 4, 8, 20, 21, 22, 33, 75, 101, 120], "Then": [3, 33, 65, 82, 124], "ciexpans": [3, 21, 33, 75], "necessari": [3, 47, 70, 72, 82, 89, 103, 124, 128, 132, 149], "handl": [3, 20, 45], "1200": [3, 47, 67, 156], "alreadi": [3, 21, 29, 43, 49, 61, 101, 131, 143, 148, 156], "fairli": [3, 101], "purpos": [3, 45, 46, 54, 70, 96, 143], "exclud": [3, 47, 133], "freez": [3, 126, 143], "n_frozen": [3, 33, 75], "120": [3, 60, 62, 67, 100, 132, 156], "themselv": [3, 4, 46, 47, 117], "easiest": [3, 133], "detlist": 3, "python": [3, 13, 18, 33, 42, 43, 67, 86, 94, 96, 154, 156], "impli": [3, 11, 16, 20, 29, 82, 88, 91, 92, 111, 117, 150], "predefin": [3, 74], "By": [3, 11, 20, 21, 22, 46, 49, 65, 70, 71, 73, 80, 91, 94, 122, 143, 144, 148], "directli": [3, 17, 21, 33, 34, 45, 72, 75, 82, 97, 113, 122, 139, 144, 148, 159], "represent": [3, 7, 11, 19, 37, 46, 65, 66, 67, 68, 69, 70, 73, 78, 88, 94, 99, 102, 115, 133, 148], "charact": [3, 19, 24, 26, 38, 43, 90, 102, 105, 148, 153], "doubli": [3, 4, 7, 10, 14, 21, 24, 25, 28, 33, 69, 72, 90, 97, 120, 122, 128, 143, 149], "list": [3, 4, 11, 24, 28, 29, 33, 42, 43, 52, 67, 72, 75, 81, 91, 101, 122, 124, 128, 140, 143, 144, 149], "det": [3, 19, 30, 33], "determinant_list": [3, 33], "occ_alpha": [3, 33], "occ_beta": [3, 33], "222aa0": [3, 24], "22a2a0": 3, "2a22a0": 3, "a222a0": 3, "22aa20": 3, "2a2a20": 3, "a22a20": 3, "2aa220": 3, "a2a220": 3, "aa2220": [3, 24], "22aaab": 3, "2a2aab": 3, "a22aab": 3, "2aa2ab": 3, "a2a2ab": 3, "aa22ab": 3, "2aaa2b": 3, "a2aa2b": 3, "aa2a2b": 3, "aaa22b": 3, "222a0a": 3, "22a20a": 3, "2a220a": 3, "a2220a": 3, "22aaba": 3, "2a2aba": 3, "a22aba": 3, "2aa2ba": 3, "a2a2ba": 3, "aa22ba": 3, "22aa02": 3, "2a2a02": 3, "a22a02": 3, "2aa202": 3, "a2a202": 3, "aa2202": 3, "2aaab2": 3, "a2aab2": 3, "aa2ab2": 3, "aaa2b2": 3, "2220aa": 3, "22abaa": 3, "2a2baa": 3, "a22baa": 3, "22a02a": 3, "2a202a": 3, "a2202a": 3, "2aab2a": 3, "a2ab2a": 3, "aa2b2a": 3, "22a0a2": 3, "2a20a2": 3, "a220a2": 3, "2aaba2": 3, "a2aba2": 3, "aa2ba2": 3, "2aa022": 3, "a2a022": 3, "aa2022": 3, "aaab22": 3, "22baaa": 3, "2202aa": 3, "2ab2aa": 3, "a2b2aa": 3, "220a2a": 3, "2aba2a": 3, "a2ba2a": 3, "2a022a": 3, "a2022a": 3, "aab22a": 3, "220aa2": 3, "2abaa2": 3, "a2baa2": 3, "2a02a2": 3, "a202a2": 3, "aab2a2": 3, "2a0a22": 3, "a20a22": 3, "aaba22": 3, "aa0222": 3, "2b2aaa": 3, "2ba2aa": 3, "2022aa": 3, "ab22aa": 3, "2baa2a": 3, "202a2a": 3, "ab2a2a": 3, "20a22a": 3, "aba22a": 3, "a0222a": 3, "2baaa2": 3, "202aa2": 3, "ab2aa2": 3, "20a2a2": 3, "aba2a2": 3, "a022a2": 3, "20aa22": 3, "abaa22": 3, "a02a22": 3, "a0a222": 3, "b22aaa": 3, "b2a2aa": 3, "ba22aa": 3, "0222aa": 3, "b2aa2a": 3, "ba2a2a": 3, "022a2a": 3, "baa22a": 3, "02a22a": 3, "0a222a": 3, "b2aaa2": 3, "ba2aa2": 3, "022aa2": 3, "baa2a2": 3, "02a2a2": 3, "0a22a2": 3, "baaa22": 3, "02aa22": 3, "0a2a22": 3, "0aa222": 3, "cioper": [3, 33, 75], "molecular": [3, 4, 5, 7, 8, 10, 11, 12, 14, 15, 16, 17, 19, 20, 21, 22, 24, 28, 29, 31, 33, 34, 35, 36, 38, 39, 40, 43, 45, 46, 47, 48, 52, 54, 55, 56, 57, 58, 59, 60, 61, 66, 67, 69, 70, 71, 74, 75, 76, 78, 80, 88, 89, 90, 96, 97, 98, 99, 100, 101, 102, 103, 105, 109, 111, 113, 117, 120, 121, 122, 124, 129, 130, 131, 132, 133, 140, 141, 142, 143, 144, 145, 148, 150, 152, 153, 156], "ci_ham": [3, 33], "compute_hint": [3, 33], "construct": [3, 8, 10, 18, 39, 43, 45, 46, 47, 49, 51, 53, 60, 62, 67, 69, 72, 73, 80, 101, 106, 113, 118, 124, 125, 128, 131, 133, 136, 139, 142, 143, 144, 145, 148, 149, 153, 157], "hij": [3, 33], "h_ci": 3, "zero": [3, 4, 7, 10, 14, 20, 21, 24, 27, 28, 29, 31, 33, 38, 39, 45, 46, 47, 52, 65, 70, 74, 75, 76, 81, 82, 83, 84, 86, 88, 97, 98, 99, 100, 102, 106, 111, 113, 115, 120, 124, 125, 130, 131, 132, 139, 143, 144, 145, 148, 151, 156, 157], "n_determin": [3, 21, 33], "idet": [3, 33], "jdet": 3, "w": [3, 7, 14, 21, 39, 67, 70, 78, 82, 89, 99, 100, 113, 124, 142, 144, 150, 153], "v": [3, 7, 14, 15, 16, 17, 18, 19, 21, 22, 25, 26, 27, 30, 31, 36, 39, 40, 52, 55, 65, 67, 75, 76, 78, 80, 88, 89, 91, 94, 99, 100, 108, 111, 113, 120, 125, 150], "147": [3, 156], "72339194": 3, "49488796": 3, "48991742": 3, "39178263": 3, "31022148": 3, "27297821": 3, "14365547": 3, "08916312": 3, "08242927": 3, "07852818": 3, "05836503": 3, "00699461": 3, "146": [3, 72, 125], "99905665": 3, "97927131": 3, "95353201": 3, "9354175": 3, "93382892": 3, "88967934": 3, "88480791": 3, "83509186": 3, "82598782": 3, "75346539": 3, "75077715": 3, "74829521": 3, "74125314": 3, "71397134": 3, "70255217": 3, "64273756": 3, "6366741": 3, "56810118": 3, "53923066": 3, "48989258": 3, "48113701": 3, "47615159": 3, "43900556": 3, "43155944": 3, "41314138": 3, "40393925": 3, "37524854": 3, "34672641": 3, "33446114": 3, "27975068": 3, "2749686": 3, "26378644": 3, "22065448": 3, "21747518": 3, "20946767": 3, "19236321": 3, "17110856": 3, "16624582": 3, "13162568": 3, "10690359": 3, "0604229": 3, "05944823": 3, "05247853": 3, "04847397": 3, "97547061": 3, "89703574": 3, "89485308": 3, "89424117": 3, "88770488": 3, "80696382": 3, "77118848": 3, "76968622": 3, "76657329": 3, "75603435": 3, "75598202": 3, "70968766": 3, "69813332": 3, "68735456": 3, "66670629": 3, "66467605": 3, "08963409": 3, "144": [3, 67, 115], "99400313": 3, "89601606": 3, "86160532": 3, "inde": [3, 21, 33, 65, 72, 74, 82, 111, 120, 122, 148], "higher": [3, 7, 8, 19, 26, 27, 35, 46, 47, 55, 67, 72, 74, 82, 84, 88, 89, 91, 92, 98, 101, 120, 122, 125, 129, 141, 143, 144, 149], "m_": [3, 16, 19, 20, 25, 31, 49, 66, 70, 72, 78, 82, 91, 120, 125, 143, 148, 150], "quintet": 3, "eigenvector": [3, 10, 45, 46, 52, 66, 70, 71, 72, 94, 113], "set_printopt": [3, 4, 10, 26, 27, 33, 38, 70, 72, 81, 97], "formatt": [3, 33], "float_kind": [3, 33], "969": [3, 144], "176": [3, 150], "049": 3, "003": [3, 24, 26, 70], "057": 3, "066": [3, 67], "036": [3, 26, 82, 150], "006": [3, 24], "007": [3, 20], "019": [3, 70, 153], "largest": [3, 11, 18, 20, 21, 52, 94, 96, 139, 142, 144], "curiou": 3, "happen": [3, 21, 52, 74, 90, 143, 153], "answer": [3, 20, 43, 92], "condon": [3, 33, 100], "rule": [3, 11, 25, 28, 46, 82, 91, 94, 100, 103, 105, 113], "term": [3, 6, 7, 8, 15, 16, 19, 20, 22, 24, 25, 26, 27, 31, 33, 39, 43, 44, 45, 46, 49, 52, 53, 55, 58, 59, 60, 61, 70, 71, 72, 73, 74, 78, 80, 82, 88, 89, 90, 91, 96, 97, 100, 111, 113, 141, 142, 143, 149], "formul": [3, 5, 12, 15, 19, 21, 43, 67, 73, 104, 144, 149, 153], "singli": [3, 21, 24, 33, 72, 75, 97, 122, 125, 143], "compar": [3, 4, 5, 15, 18, 19, 20, 21, 22, 27, 33, 34, 38, 41, 46, 49, 52, 56, 59, 60, 62, 70, 72, 73, 76, 83, 86, 88, 90, 92, 94, 96, 99, 106, 111, 113, 124, 126, 128, 129, 132, 136, 142, 143, 144, 146, 147, 148, 149, 151, 153], "easi": [3, 20, 21, 43, 45, 46, 47, 75, 105, 144], "deriv": [3, 4, 7, 19, 21, 22, 31, 33, 38, 45, 46, 48, 49, 50, 52, 55, 60, 61, 66, 67, 68, 73, 76, 80, 84, 86, 89, 90, 91, 98, 99, 100, 108, 111, 130, 132, 142, 150, 158], "standard": [3, 4, 8, 18, 19, 20, 21, 26, 43, 55, 71, 75, 89, 91, 99, 101, 108, 120, 141, 143, 144, 149, 150], "quantiz": [3, 9, 33, 72, 75], "reconcil": 3, "Being": 3, "those": [3, 6, 10, 18, 21, 25, 42, 43, 45, 46, 47, 48, 69, 72, 75, 80, 82, 90, 91, 92, 94, 105, 115, 124, 130, 143], "mo": [3, 4, 9, 10, 11, 13, 14, 15, 18, 21, 24, 25, 26, 28, 29, 33, 38, 39, 46, 49, 70, 71, 72, 75, 81, 86, 88, 94, 96, 97, 102, 105, 113, 120, 122, 125, 126, 137, 142, 143, 147, 148, 149, 150, 153, 157], "leav": [3, 11, 15, 25, 46, 63, 66, 91, 130, 132], "outsid": [3, 18, 20, 21, 34, 52, 90, 124], "inact": [3, 20, 21, 24, 33, 75, 90, 101, 111, 120, 124], "done": [3, 17, 20, 21, 42, 46, 47, 55, 70, 72, 73, 101, 106, 113, 117, 120, 125, 130, 133, 142, 143, 144, 148, 149, 150], "i_": [3, 61, 82], "h_": [3, 15, 21, 29, 33, 46, 49, 66, 72], "qi": [3, 46, 49], "ao": [3, 6, 7, 9, 18, 21, 24, 26, 28, 33, 38, 39, 46, 49, 61, 70, 75, 91, 113], "mu": [3, 6, 8, 15, 16, 33, 38, 39, 40, 46, 49, 61, 75, 76, 82, 83, 84, 86, 88, 89, 91, 98, 99, 100, 102, 111, 113, 117, 130, 144, 146, 150], "nu": [3, 15, 40, 46, 49, 66, 76, 89, 98], "lambda": [3, 14, 22, 25, 33, 36, 38, 45, 46, 49, 55, 61, 66, 82, 91, 94, 113, 117, 150], "sigma": [3, 10, 11, 21, 26, 33, 46, 47, 49, 71, 72, 76, 82, 83, 90, 91, 92, 98, 101, 102, 105, 120, 122, 124, 142, 144, 151], "repuls": [3, 4, 7, 8, 14, 15, 16, 20, 22, 25, 33, 35, 46, 47, 69, 70, 80, 120, 125, 143, 144, 148], "v_": [3, 7, 19, 39, 46, 47, 49, 80, 108], "nn": [3, 14, 46, 49], "nin": [3, 21], "n_inact": [3, 21], "nact": [3, 21], "n_activ": [3, 20, 21, 33, 120], "nba": [3, 21, 26], "n_orbit": 3, "v_nn": 3, "v_nuc": [3, 7, 14, 21, 39], "nuclear_repulsion_energi": [3, 7, 14, 21, 22, 25, 39], "kinetic_drv": [3, 7, 14, 17, 21, 39], "nucpot_drv": [3, 7, 14, 17, 21, 39], "nuclearpotentialintegralsdriv": [3, 7, 14, 17, 21, 22, 25, 39], "eri_drv": [3, 7, 14, 17, 21, 22, 25, 39], "electronrepulsionintegralsdriv": [3, 7, 14, 17, 21, 22, 39], "compute_in_memori": [3, 7, 14, 17, 21, 22, 25, 33, 39, 70, 86, 113], "alpha_to_numpi": [3, 21], "cact": [3, 21], "din": [3, 21], "mi": 3, "ni": 3, "mn": [3, 61, 70, 72, 86, 117, 159], "jin": [3, 21, 67], "mnl": 3, "coulomb": [3, 4, 7, 15, 19, 25, 33, 47, 49, 67, 73, 98, 143, 150], "kin": [3, 21], "mln": 3, "fin": [3, 21], "ein": [3, 21, 33], "transform": [3, 9, 10, 11, 15, 18, 21, 24, 28, 33, 43, 46, 66, 70, 71, 72, 75, 82, 84, 94, 97, 102, 130, 131, 132, 150, 153, 156], "ftu": [3, 21, 33], "qu": [3, 21, 46, 75], "pt": [3, 21, 46, 75], "tu": [3, 21, 75, 150], "pqrw": [3, 21], "pqr": [3, 17, 21, 22, 28, 29, 46, 70], "sw": [3, 21], "pqvw": [3, 21], "rv": [3, 21], "puvw": [3, 21], "tuvw": [3, 21, 33], "assert": [3, 73], "inen": [3, 33], "0e": [3, 7, 20, 65, 70, 72, 75, 76, 86, 89, 90, 98, 100, 101, 106, 120, 124, 125, 142, 143, 144, 148, 151, 153], "assert_almost_equ": [3, 33], "sc_diag": [3, 33], "occa": [3, 33, 143, 144], "occb": [3, 33, 143, 144], "inc": [3, 33], "sc_1exc": [3, 33], "ss_occ": [3, 33], "os_occ": [3, 33], "opposit": [3, 11, 20, 22, 28, 33, 47, 55, 60, 64, 96, 143], "sc_ss1exc": [3, 33], "sc_os1exc": [3, 33], "part": [3, 7, 8, 15, 19, 22, 27, 29, 33, 35, 38, 39, 43, 46, 47, 61, 70, 71, 72, 83, 90, 94, 97, 100, 101, 103, 104, 113, 124, 133, 142, 144, 149, 153, 156], "brought": [3, 55, 123], "maximum": [3, 8, 14, 20, 27, 33, 60, 65, 67, 86, 122], "concord": 3, "produc": [3, 47, 82, 92, 124], "switch": [3, 52, 74, 99, 101, 111], "until": [3, 14, 16, 19, 41, 60], "introduc": [3, 4, 9, 10, 14, 15, 16, 19, 22, 24, 25, 26, 27, 29, 36, 38, 46, 47, 53, 55, 56, 65, 69, 73, 74, 80, 82, 86, 88, 90, 91, 97, 100, 105, 122, 143, 144, 149], "phase": [3, 15, 29, 30, 33, 41, 46, 47, 67, 82, 88, 111, 113, 142, 144, 147], "conveni": [3, 4, 14, 15, 26, 29, 42, 46, 70, 88, 91, 97, 100, 124, 150], "achiev": [3, 5, 11, 14, 36, 43, 47, 60, 66, 67, 69, 101, 113, 141, 143, 144, 149, 153], "appli": [3, 11, 16, 19, 20, 21, 29, 33, 46, 47, 58, 60, 65, 66, 69, 70, 72, 74, 75, 76, 82, 83, 91, 96, 98, 99, 100, 101, 111, 117, 122, 125, 128, 144, 149], "twice": [3, 27, 31, 72], "keep": [3, 22, 69, 91, 101, 122, 136], "bring": [3, 21, 75, 101, 143, 144], "excite_alpha": [3, 33], "excite_beta": [3, 33], "associ": [3, 6, 9, 10, 11, 13, 15, 16, 18, 22, 24, 25, 26, 27, 29, 31, 35, 36, 38, 47, 78, 82, 86, 88, 91, 94, 99, 100, 102, 105, 111, 113, 117, 130, 132, 143, 150], "correct": [3, 8, 9, 19, 20, 21, 27, 43, 46, 47, 52, 55, 62, 65, 67, 70, 72, 80, 84, 89, 96, 111, 122, 128, 133, 143, 144, 149, 150], "With": [3, 4, 10, 12, 15, 20, 21, 25, 27, 30, 38, 45, 46, 47, 65, 74, 78, 88, 91, 99, 102, 105, 113, 122, 125, 128, 136, 137, 139, 143, 144, 149, 150, 151], "rewrit": [3, 46], "ham": [3, 67], "unocc_alpha": [3, 33], "excdet": [3, 33], "continu": [3, 33, 81, 96, 141, 148], "phase2": [3, 33], "exc2det": [3, 33], "unocc_beta": [3, 33], "structur": [3, 5, 8, 9, 13, 19, 21, 31, 33, 38, 39, 43, 44, 45, 46, 47, 48, 56, 58, 59, 60, 62, 64, 67, 68, 70, 74, 82, 88, 98, 100, 113, 120, 123, 124, 125, 126, 129, 131, 136, 140, 142, 144, 145, 146, 149, 150, 153, 157], "non": [3, 16, 19, 20, 21, 22, 25, 29, 33, 35, 45, 46, 52, 60, 70, 72, 73, 74, 76, 82, 84, 89, 90, 91, 98, 99, 108, 113, 117, 120, 123, 128, 130, 141, 142, 144, 145, 149], "723": 3, "495": 3, "seen": [3, 4, 6, 7, 14, 18, 21, 22, 27, 31, 39, 49, 55, 72, 74, 78, 82, 83, 84, 90, 92, 96, 105, 113, 122, 130, 139, 142, 143, 144, 148, 149], "n_": [3, 15, 17, 21, 66, 74, 86, 94, 113], "grow": 3, "extrem": [3, 55, 96, 143, 145, 148], "rapidli": [3, 19, 144], "even": [3, 20, 21, 27, 33, 39, 43, 49, 53, 74, 75, 82, 89, 90, 91, 98, 101, 108, 120, 121, 122, 144, 149], "faster": [3, 4], "exampl": [3, 5, 11, 12, 17, 18, 20, 24, 25, 26, 27, 31, 33, 38, 43, 45, 46, 47, 49, 52, 55, 60, 62, 65, 68, 69, 73, 74, 75, 76, 78, 88, 90, 91, 92, 96, 97, 98, 100, 102, 103, 105, 106, 111, 113, 120, 133, 136, 137, 139, 140, 143, 144, 147, 148, 150, 151], "210": [3, 156], "878": 3, "824": 3, "885": 3, "scale": [3, 17, 31, 36, 43, 47, 53, 55, 59, 67, 70, 71, 82, 90, 113, 123, 130, 131, 132, 133, 136, 137, 139, 143, 144, 154, 156, 159], "nearli": [3, 21], "tb": 3, "spars": 3, "storag": [3, 14, 71], "footprint": 3, "enorm": 3, "rare": [3, 100, 120], "ever": [3, 72], "entir": [3, 15, 21, 26, 70, 92, 130], "usual": [3, 20, 21, 33, 43, 46, 47, 50, 65, 66, 71, 74, 76, 82, 89, 98, 101, 120, 123, 143, 149], "focus": [3, 5, 43, 47, 82, 129, 141, 143, 144, 149, 152, 155], "progress": [3, 53], "effect": [3, 4, 9, 11, 14, 15, 19, 20, 21, 27, 33, 41, 46, 47, 67, 69, 72, 73, 74, 76, 82, 89, 96, 98, 124, 129, 141, 144, 148, 151], "boldsymbol": [3, 10, 11, 15, 17, 21, 33, 38, 39, 45, 46, 49, 52, 61, 70, 73, 75, 82, 91, 97, 111, 113, 132], "context": [3, 25, 43], "davidson": [3, 70, 75, 106, 113, 125, 141, 144], "trial": [3, 16, 76, 89, 90, 98, 124, 148], "accord": [3, 11, 14, 15, 17, 19, 21, 22, 24, 25, 27, 28, 29, 30, 38, 46, 55, 72, 82, 88, 91, 98, 99, 100, 111, 113, 126, 136, 142], "dav": 3, "h_0": [3, 22, 27], "r": [3, 4, 6, 7, 8, 11, 14, 15, 16, 17, 18, 19, 20, 21, 24, 25, 26, 27, 28, 29, 30, 31, 33, 36, 38, 39, 40, 45, 46, 47, 49, 55, 59, 62, 65, 66, 67, 70, 72, 73, 78, 81, 82, 84, 90, 91, 92, 94, 96, 97, 98, 99, 100, 102, 105, 108, 113, 120, 124, 125, 131, 132, 142, 143, 144, 150, 154, 156, 157], "precondition": 3, "residu": [3, 19, 33, 70, 72, 73, 75, 76, 78, 89, 90, 98, 99, 117, 124, 148], "improv": [3, 21, 27, 33, 41, 47, 55, 60, 62, 67, 72, 75, 94, 101, 128, 143, 145, 149], "small": [3, 4, 18, 19, 20, 21, 22, 25, 26, 35, 38, 42, 43, 46, 47, 49, 52, 53, 55, 60, 69, 72, 86, 89, 91, 92, 99, 101, 102, 111, 113, 115, 122, 126, 136, 142, 143, 144, 148], "sometim": [3, 21, 26, 43, 46, 69, 75, 120, 124, 150], "quantiti": [3, 6, 20, 30, 38, 46, 70, 73, 74, 82, 84, 89, 91, 98, 99, 111, 150], "equal": [3, 4, 7, 8, 10, 11, 14, 15, 16, 18, 19, 20, 22, 24, 25, 26, 27, 28, 29, 30, 31, 36, 38, 41, 46, 47, 55, 78, 82, 83, 86, 88, 89, 98, 100, 101, 102, 113, 120, 122, 124, 143, 144, 149, 150], "hundr": [3, 35, 53], "million": 3, "had": [3, 42, 49, 122], "trivial": [3, 15, 16, 25, 30, 46, 61, 83, 88, 101, 113, 148], "vec0": [3, 33], "random": [3, 27, 46, 55, 67, 82, 97, 111, 113], "rand": [3, 27, 97], "dot": [3, 6, 7, 14, 18, 60, 61, 82, 86, 91, 99, 106, 111, 113, 143, 148], "domin": [3, 7, 19, 72, 75, 86, 89, 105, 113, 120, 142, 143, 144, 153], "perform": [3, 6, 7, 8, 10, 11, 13, 14, 15, 18, 19, 20, 21, 22, 38, 39, 42, 43, 45, 46, 47, 51, 52, 56, 58, 60, 62, 64, 65, 67, 68, 72, 76, 82, 89, 92, 97, 98, 99, 102, 105, 113, 115, 120, 122, 124, 125, 128, 132, 133, 136, 137, 139, 142, 143, 144, 145, 148, 149, 150, 153, 156, 157], "hdiag": 3, "lowest_st": 3, "argmin": [3, 44], "initialis": [3, 21], "resnorm": 3, "istep": 3, "0001": [3, 20, 81, 90, 101, 105, 120, 124, 156], "norm": [3, 7, 14, 20, 21, 33, 36, 38, 39, 52, 60, 61, 70, 72, 75, 89, 90, 101, 120, 124, 125, 131, 143, 148], "sigvec0": 3, "recomput": 3, "scratch": [3, 43, 132], "prevent": [3, 29, 38, 120], "diverg": [3, 82], "vec1": [3, 33], "orthonorm": [3, 10, 15, 21, 27, 29, 30, 33, 49, 72, 97], "sigvec1": 3, "smallham": 3, "62953840021837": 3, "71940126561879": 3, "72318392969424": 3, "72336778079267": 3, "72338867249744": 3, "72339137919488": 3, "7233918396856": 3, "72339191989158": 3, "72339193438057": 3, "diagonalis": 3, "segment": [3, 153], "n_guess": 3, "definit": [3, 9, 20, 21, 46, 65, 75, 82, 84, 90, 91, 98, 99, 101, 120, 124], "virtual": [3, 4, 14, 17, 18, 20, 21, 22, 33, 46, 49, 70, 72, 75, 80, 86, 88, 90, 97, 98, 99, 101, 106, 111, 113, 120, 124, 126, 128, 142, 143, 144], "casscf": [3, 20, 21, 33, 75, 90, 92, 101, 120, 122, 124], "ca": [3, 17, 20, 21, 24, 33, 46, 75, 90, 101, 120, 122, 124, 159], "subspac": [3, 20, 29, 38, 70, 72, 75, 76, 89, 90, 98, 120, 125, 143, 148], "1e": [3, 7, 14, 17, 18, 20, 21, 24, 28, 33, 39, 41, 52, 60, 70, 72, 75, 81, 90, 101, 120, 124, 131], "08": [3, 7, 20, 67, 70, 72, 75, 76, 90, 98, 100, 101, 120, 124, 143], "squar": [3, 14, 34, 36, 41, 45, 47, 52, 61, 75, 89, 94, 100, 102, 153], "averag": [3, 8, 14, 20, 43, 52, 55, 67, 72, 74, 75, 76, 89, 90, 92, 93, 98, 120, 122, 124], "grad": [3, 20, 75, 90, 101, 120, 124], "time": [3, 7, 8, 11, 16, 17, 18, 19, 20, 22, 25, 26, 27, 29, 31, 38, 43, 46, 47, 49, 53, 61, 66, 67, 70, 72, 73, 74, 75, 76, 80, 82, 84, 86, 89, 90, 94, 96, 97, 98, 101, 103, 108, 109, 111, 113, 120, 122, 123, 124, 125, 133, 143, 144, 146, 148, 150, 151, 154, 156, 157], "629538400": 3, "6e": [3, 20, 75, 90, 101, 120, 124], "01": [3, 7, 8, 14, 20, 21, 22, 47, 60, 65, 70, 72, 75, 76, 81, 89, 90, 94, 98, 99, 100, 101, 113, 120, 124, 125, 142, 143, 144, 148, 151, 156], "719401373": 3, "02": [3, 4, 7, 14, 20, 21, 65, 67, 70, 72, 75, 76, 89, 90, 94, 98, 100, 101, 120, 122, 124, 143, 148, 156, 157], "03": [3, 7, 14, 20, 21, 65, 67, 70, 72, 75, 76, 89, 90, 94, 98, 100, 101, 120, 122, 124, 125, 143, 148, 156], "723346247": 3, "9e": [3, 20, 75, 90, 101, 120, 124], "05": [3, 4, 14, 18, 20, 21, 28, 33, 47, 52, 59, 67, 70, 72, 75, 76, 89, 90, 96, 98, 99, 100, 101, 113, 120, 122, 124, 125, 130, 131, 132, 133, 136, 137, 139, 143, 154, 156, 159], "723390649": 3, "06": [3, 7, 14, 20, 41, 47, 67, 70, 72, 75, 89, 90, 100, 101, 120, 122, 124, 125, 143, 148, 156], "723391935": 3, "3e": [3, 20, 65, 75, 90, 101, 120, 124], "7e": [3, 20, 75, 90, 101, 120, 124, 150], "09": [3, 20, 26, 65, 70, 72, 75, 90, 98, 100, 101, 120, 124, 125, 130, 143, 148], "723391938": 3, "8e": [3, 20, 75, 90, 101, 120, 124, 150], "72339193758123": 3, "95550": 3, "96583": 3, "04380": 3, "03557": 3, "cours": [3, 14, 20, 21, 36, 50, 101], "fulli": [3, 38, 39, 43, 46, 53, 96, 120, 143], "fewer": [3, 52, 90, 142], "despit": [3, 25, 46, 53, 143, 144, 149], "stricter": 3, "old": [3, 26, 46, 144], "intermedi": [3, 17, 20, 21, 27, 67, 68, 70, 73, 88, 144], "mcscf": [3, 20, 43, 46, 90, 93, 120, 123], "particl": [3, 6, 8, 9, 19, 21, 24, 25, 26, 31, 36, 38, 39, 46, 55, 61, 68, 70, 71, 72, 73, 94, 105, 108, 120, 122, 144, 148, 150, 153, 158], "d_": [3, 6, 15, 18, 21, 24, 28, 29, 33, 36, 46, 49, 61, 71, 91, 102, 105, 150, 153], "_p": [3, 25, 29, 33, 70, 72, 73, 75, 97], "_q": [3, 29, 33, 45, 52, 60, 70, 72, 73, 75, 82], "simplifi": [3, 21, 45, 46, 49, 69, 76, 91, 98, 125, 133], "delta_": [3, 15, 29, 38, 46, 49, 70, 72, 80, 84, 86, 91, 97, 100, 106, 113], "otherwis": [3, 46, 92, 132, 143], "exercis": [3, 46, 93, 98, 123, 141, 142], "try": [3, 10, 20, 42, 43, 55, 92, 101, 124, 128], "intuit": [3, 43, 101, 120], "origin": [3, 8, 11, 14, 17, 28, 31, 34, 38, 47, 62, 66, 73, 74, 84, 91, 94, 120, 141, 142, 143, 144], "born": [3, 47, 55, 100], "power": [3, 22, 43, 82, 89, 91, 102], "undeni": 3, "sort": [3, 19, 21, 70, 81], "across": [3, 43, 101], "offer": [3, 8, 18, 19, 36, 43, 60, 72, 96], "measur": [3, 4, 18, 55, 67, 74, 76, 84, 98, 141, 142, 143, 144, 151], "far": [3, 8, 21, 42, 43, 53, 72, 90, 91, 100, 101, 117, 120, 144], "reflect": [3, 11, 20, 63, 74, 122], "signific": [3, 20, 21, 27, 33, 53, 92, 96, 141, 142, 143, 144], "deviat": [3, 8, 47, 84, 120, 139, 143, 149, 150], "pictur": [3, 143, 144, 148], "chapter": [3, 21, 43, 53, 55, 67, 91, 101, 103, 120, 121, 123, 140, 147, 148, 158], "multiconfigur": [3, 23, 43, 67, 90, 93, 124], "dpq": [3, 33], "get_active_dens": [3, 4, 21, 33], "o2": [3, 33, 142], "flip": [3, 67, 128, 148, 149], "966": 3, "955": 3, "044": 3, "recogn": [3, 15, 16, 19, 35, 91], "earlier": [3, 5, 20], "come": [3, 5, 20, 21, 26, 47, 49, 55, 80, 82, 88, 96, 108, 142], "especi": [3, 47, 52, 143], "anti": [3, 11, 16, 29, 30, 33, 46, 72, 82, 129], "last": [3, 19, 27, 29, 33, 46, 65, 82, 91, 117, 120, 156], "benchmark": [3, 67, 128, 149], "fast": [3, 21, 43, 47, 52, 60, 67], "factori": 3, "polar": [3, 11, 20, 26, 39, 41, 61, 67, 68, 70, 72, 74, 76, 89, 91, 98, 99, 113, 117, 118, 126, 128, 143, 144, 149], "zeta": [3, 26, 49, 128, 149, 157], "903": 3, "316": [3, 67], "260": [3, 10], "expens": [3, 21, 60, 72, 128, 149], "obviou": [3, 21, 105], "cannot": [3, 11, 21, 45, 49, 71, 74, 76, 82, 89, 106, 124, 143, 144, 149], "taken": [3, 33, 46, 49, 55, 60, 61, 66, 71, 72, 74, 82, 89, 111, 124, 136, 142, 143, 144, 147, 148, 149], "turn": [3, 24, 25, 45, 61, 74, 82, 100, 105, 120, 125, 133, 136, 142, 143], "involv": [3, 6, 17, 21, 22, 28, 29, 34, 46, 47, 49, 61, 64, 69, 70, 71, 72, 74, 76, 80, 82, 84, 89, 90, 91, 94, 98, 100, 101, 102, 105, 113, 123, 124, 128, 129, 130, 132, 141, 142, 143, 149, 153], "after": [3, 10, 15, 19, 20, 21, 28, 38, 45, 46, 47, 49, 55, 60, 71, 82, 92, 101, 156], "h2o_xyz": [3, 6, 10, 14, 17, 18, 21, 22, 33, 39, 72, 83, 86, 132], "740848095288": [3, 6, 7, 10, 14, 17, 18, 21, 22, 72, 76, 83, 86, 89, 98], "582094932012": [3, 6, 7, 10, 14, 17, 18, 21, 22, 72, 76, 83, 86, 89, 98], "h2o": [3, 70, 72, 132], "h2o_orb": 3, "e_hf": [3, 20, 21, 33, 39, 120, 143], "cisd": [3, 21, 22, 75], "cisdt": [3, 75], "cisdtq": [3, 75], "fullci": [3, 20, 21, 101, 120], "e_fci": [3, 20, 21, 22, 120], "corr_perc": 3, "211": [3, 142, 144, 151], "plot": [3, 4, 8, 13, 14, 18, 20, 21, 27, 28, 31, 33, 47, 52, 58, 59, 60, 62, 65, 70, 75, 92, 94, 96, 100, 101, 102, 105, 106, 113, 120, 124, 126, 130, 131, 132, 137, 142, 143, 144, 146, 148, 151, 153, 156, 157], "212": [3, 142, 144, 151], "tight_layout": [3, 20, 21, 33, 47, 52, 62, 75, 92, 101, 106, 120, 124, 125, 130, 131, 132, 142, 143, 144, 148, 151, 156], "recov": [3, 22], "247e": 3, "11": [3, 7, 8, 14, 20, 21, 24, 31, 34, 36, 62, 65, 67, 70, 72, 75, 76, 81, 90, 91, 100, 101, 105, 113, 120, 122, 123, 124, 125, 142, 143, 144, 150, 156], "95": [3, 20, 21, 33, 52, 67, 72, 98, 100, 101, 120, 143, 156], "14": [3, 7, 13, 14, 18, 20, 21, 24, 27, 33, 39, 44, 62, 67, 72, 86, 89, 90, 101, 113, 120, 122, 123, 124, 125, 143, 144, 148, 156], "84": [3, 70, 120, 125, 143, 156], "99": [3, 7, 20, 24, 62, 67, 70, 120, 122, 143, 148, 156], "88": [3, 20, 70, 100, 120, 125, 143, 156], "low": [3, 20, 47, 55, 72, 98, 128, 130, 143, 144, 147, 148], "odd": [3, 72, 73, 91], "much": [3, 4, 5, 8, 18, 20, 25, 42, 43, 46, 49, 55, 82, 84, 98, 101, 120, 122, 123, 124, 143, 144], "rise": [3, 26, 46, 47, 82, 102, 103, 123], "remark": [3, 5, 20, 82], "count": [3, 18], "141": [3, 26, 67, 70, 100, 156], "828": 3, "clearli": [3, 4, 18, 20, 21, 27, 31, 47, 122, 142, 143], "scheme": [3, 6, 14, 16, 18, 19, 20, 22, 33, 34, 36, 38, 41, 46, 52, 53, 61, 67, 68, 70, 72, 76, 89, 98, 108, 118, 120, 122, 125, 128, 141, 142, 143, 144, 148, 149], "captur": [3, 4, 19, 21, 45, 73, 143, 149], "fraction": [3, 5, 19, 21, 46, 55], "dimer": [3, 8, 22, 67, 80, 94, 102, 105, 120, 153], "exactli": [3, 20, 43, 46, 122, 143], "monom": [3, 22, 80, 102, 105, 153], "\u00e5": [3, 8, 20, 21, 22, 33, 47, 52, 67, 72, 100, 102, 105, 120, 139], "dimer_xyz": [3, 8, 22, 94, 102, 105, 153], "e_2h2o": 3, "26": [3, 14, 20, 25, 26, 67, 75, 84, 90, 91, 100, 101, 113, 120, 122, 125, 143, 144, 156], "6f": [3, 34, 36, 38, 39, 41, 78, 83, 86, 89, 98, 113, 122], "152": [3, 125], "215193": 3, "224357": 3, "009163": 3, "systemat": [3, 67, 149], "failur": [3, 8, 153], "error": [3, 6, 10, 14, 18, 20, 21, 27, 34, 36, 39, 41, 46, 55, 67, 69, 70, 72, 90, 101, 120, 125, 141, 144, 148, 149], "whose": [3, 49, 91], "psi_a": [3, 15, 25, 99, 150], "ijab": [3, 21, 33, 46, 70, 72], "klcd": [3, 46, 72], "psi_b": [3, 25, 86, 99, 150], "kl": [3, 7, 10, 14, 21, 39, 46, 49, 71, 72], "cd": [3, 17, 38, 42, 46, 72, 102], "apart": [3, 8, 15, 22, 43, 70, 72], "ones": [3, 7, 14, 18, 21, 33, 45, 46, 49, 72, 139, 144], "begin": [3, 6, 8, 11, 14, 15, 16, 17, 19, 20, 22, 24, 25, 26, 27, 28, 29, 30, 31, 33, 36, 38, 45, 46, 47, 49, 55, 60, 71, 76, 82, 83, 84, 86, 88, 89, 91, 94, 97, 98, 99, 101, 102, 106, 111, 113, 117, 122], "align": [3, 6, 8, 15, 17, 20, 22, 24, 25, 27, 28, 29, 31, 33, 47, 49, 55, 60, 74, 82, 83, 86, 88, 96, 97, 102, 106, 113, 122, 144], "big": [3, 7, 14, 15, 16, 17, 18, 19, 21, 22, 24, 25, 27, 28, 29, 30, 31, 33, 36, 38, 41, 46, 49, 52, 66, 72, 76, 82, 86, 88, 94, 97, 98, 113, 117], "c_0": [3, 27], "_0": [3, 16, 22, 27, 38, 66, 76, 78, 84, 86, 88, 89, 91, 98, 99, 111, 123], "qquad": [3, 6, 7, 16, 22, 25, 27, 29, 31, 36, 38, 39, 86, 88, 97, 99, 113, 150], "quadrupl": [3, 149], "subsystem": [3, 27, 42], "exist": [3, 7, 10, 16, 21, 29, 31, 33, 35, 43, 73, 74, 76, 82, 101, 108], "partial": [3, 7, 19, 21, 35, 36, 38, 39, 41, 45, 46, 47, 49, 52, 55, 83, 84, 86, 91, 96, 100, 108, 111, 130, 143, 144], "quadrupli": 3, "estim": [3, 46, 47, 65, 89, 98, 122, 134, 136, 143, 144, 145, 149], "perturb": [3, 9, 17, 21, 32, 33, 43, 46, 50, 61, 67, 68, 70, 72, 73, 76, 82, 89, 91, 98, 99, 111, 113, 143, 150], "delta": [3, 7, 8, 15, 16, 17, 19, 24, 28, 29, 33, 38, 45, 46, 47, 52, 55, 60, 65, 70, 71, 72, 74, 76, 82, 83, 86, 91, 99, 100, 105, 117, 143, 146, 148, 149, 153], "rm": [3, 74, 76, 89, 91, 98, 117, 150], "vec": [3, 33, 75, 81, 90, 91, 122, 124], "coef": [3, 24, 122], "22222222220000000000000000": 3, "965": 3, "932": 3, "2222200000000": 3, "981": [3, 101], "962": 3, "e_d_2h2o": 3, "e_d_h2o": 3, "232092": 3, "234148": 3, "002056": 3, "been": [3, 5, 7, 15, 19, 20, 21, 22, 27, 43, 46, 47, 52, 59, 61, 66, 82, 88, 89, 92, 98, 102, 103, 105, 106, 108, 113, 117, 143, 144, 148, 149, 153], "notic": [3, 29, 33, 82, 124, 143, 144], "reduc": [3, 9, 16, 20, 21, 26, 30, 38, 69, 70, 72, 73, 76, 82, 89, 97, 98, 100, 101, 106, 111, 113, 120, 125, 143, 148, 150, 156], "disappear": 3, "landscap": 3, "accur": [3, 4, 5, 12, 19, 21, 25, 43, 46, 47, 51, 67, 69, 75, 76, 83, 89, 96, 100, 101], "supplant": 3, "stem": [4, 7, 46, 82], "instantan": [4, 8], "manifest": 4, "relationship": [4, 29, 66, 91, 150], "neq": [4, 15, 38, 61, 72, 80, 98, 113], "incorrectli": [4, 21], "independ": [4, 8, 16, 22, 25, 26, 27, 31, 38, 45, 46, 49, 61, 69, 76, 84, 89, 97, 98, 99, 100, 111, 144, 150], "motion": [4, 25, 31, 66, 67, 120, 131], "aris": [4, 8, 21, 46, 74, 82, 88, 89, 101, 141, 143, 144], "primari": [4, 16], "sourc": [4, 8, 42, 43, 82, 99, 111, 117, 149], "fermion": [4, 30], "natur": [4, 9, 20, 21, 22, 27, 33, 38, 43, 67, 70, 71, 74, 75, 80, 82, 89, 90, 91, 99, 101, 102, 105, 117, 120, 122, 124, 125, 128, 141, 143, 144, 145, 149, 150, 158], "perspect": [4, 18], "discrep": [4, 22, 62, 96, 143, 144], "textrm": [4, 106, 108, 111, 113, 136, 143, 149, 151], "corr": 4, "plethora": [4, 149], "model": [4, 5, 19, 20, 27, 35, 39, 41, 43, 46, 47, 53, 54, 67, 69, 70, 92, 100, 103, 120, 125, 140, 141, 143, 144, 145, 148, 149, 159], "l\u00f6wdin": [4, 38, 67, 120], "low80": [4, 67], "wf": 4, "studi": [4, 5, 16, 18, 19, 24, 27, 31, 39, 43, 47, 67, 76, 78, 82, 89, 92, 94, 96, 102, 103, 105, 115, 117, 122, 123, 125, 142, 143, 148, 149, 153], "precis": [4, 6, 10, 21, 26, 27, 38, 46, 70, 72, 75, 81, 97, 144], "suppress": [4, 10, 26, 27, 38, 70, 72, 81, 88, 97, 131], "linewidth": [4, 10, 26, 27, 38, 97, 99, 113, 142, 157], "170": [4, 26, 62, 97, 100], "mol_str": [4, 7, 20, 21, 24, 25, 26, 28, 33, 38, 52, 75, 76, 89, 90, 98, 100, 101, 120, 122, 143, 157], "000000": [4, 20, 33, 34, 36, 41, 70, 72, 81, 89, 90, 101, 120, 122, 124, 131, 142, 143, 148], "70": [4, 20, 62, 100, 101, 120, 143, 156], "unit": [4, 8, 20, 21, 28, 31, 33, 38, 39, 47, 52, 61, 67, 70, 76, 82, 84, 91, 92, 98, 100, 120, 122, 124, 131, 144], "au": [4, 28, 38, 65, 72, 76, 84, 90, 91, 98, 113, 124, 125, 130, 131, 132, 142, 143, 144, 145, 151, 153, 156], "pvdz": [4, 6, 7, 10, 13, 14, 17, 18, 20, 22, 24, 25, 26, 28, 33, 39, 78, 92, 120, 122, 143, 149, 157], "norb": [4, 7, 10, 14, 18, 20, 24, 28, 38, 70, 86, 88, 94, 96, 113, 115, 120], "hf_energi": 4, "ci_energi": 4, "ci": [4, 20, 21, 33, 44, 49, 70, 72, 80, 90, 93, 101, 115, 118, 120, 124, 126, 143], "12870945": 4, "16339873": 4, "03468928": 4, "investig": [4, 5, 19, 27, 96, 126, 136, 143, 144], "visualizationdriv": [4, 20, 28, 70, 120, 143, 157], "orbit": [4, 6, 7, 9, 10, 11, 12, 14, 15, 17, 18, 19, 20, 21, 22, 28, 29, 31, 33, 39, 43, 46, 49, 67, 69, 70, 71, 72, 75, 80, 86, 88, 89, 90, 92, 96, 101, 102, 105, 106, 108, 111, 113, 115, 120, 121, 122, 124, 126, 141, 142, 144, 145, 148, 149, 152, 158], "vis_drv": [4, 20, 28, 70, 120, 143, 157], "get_orbital_valu": [4, 120], "coord": [4, 20, 28, 38, 52, 67, 120, 130, 131, 132, 143, 156, 157], "orbital_valu": [4, 20, 120], "get_mo": [4, 20, 120, 143, 157], "get_n1": 4, "hf_onepart_denmat": 4, "fci_onepart_denmat": 4, "n1_hf": 4, "n1_fci": 4, "endpoint": [4, 20], "axvlin": [4, 8, 120], "setp": [4, 27, 28, 31, 96, 105, 157], "gca": [4, 27, 28, 96, 105, 157], "internuclear": [4, 8, 28, 100, 120], "minor": 4, "upon": [4, 21, 82, 91], "inspect": [4, 21], "discern": 4, "middl": [4, 20, 47, 120], "compens": 4, "shortcom": [4, 101], "reveal": [4, 105, 123], "get_n12": [4, 120], "orbital_values_1": [4, 120], "orbital_values_2": [4, 120], "hf_twopart_denmat": [4, 120], "ci_twopart_denmat": [4, 120], "get_active_2body_dens": [4, 20, 21, 120], "n12_hf": [4, 120], "n12_fci": [4, 120], "probabl": [4, 20, 28, 30, 55, 69, 92, 144], "nucleu": [4, 28, 55, 61, 120, 157], "orbital_values_at_h1": [4, 120], "shown": [4, 15, 16, 27, 38, 46, 47, 49, 55, 60, 69, 72, 98, 117, 124, 141, 142, 144, 149], "asymmetri": [4, 8, 74], "correctli": [4, 52, 98], "discontinu": 4, "likewis": 4, "relat": [4, 10, 15, 16, 17, 21, 22, 24, 28, 29, 30, 31, 33, 38, 42, 43, 45, 48, 49, 52, 56, 60, 61, 65, 66, 67, 68, 70, 73, 74, 75, 76, 82, 84, 88, 89, 91, 98, 100, 103, 113, 117, 130, 132, 143, 148, 153], "inter": 4, "displai": [4, 28, 43, 120, 133], "slow": [4, 60], "coincid": [4, 82, 84], "theta": [4, 8, 31, 46, 47, 82, 84, 91, 100], "co": [4, 8, 19, 28, 31, 47, 67, 82, 133, 136, 139, 144], "sin": [4, 8, 31, 82, 88, 99, 100, 111], "n12_fci_l": 4, "180": [4, 8, 44, 47, 62], "190": [4, 100, 156], "60": [4, 7, 20, 47, 62, 89, 90, 92, 100, 101, 120, 124, 125, 143, 156], "therefor": [4, 15, 18, 20, 24, 38, 46, 64, 65, 71, 72, 74, 80, 82, 89, 91, 96, 97, 101, 102, 113, 115, 150], "qualiti": [4, 6, 18, 34, 36, 41, 78, 89, 136], "sharper": 4, "why": [4, 20, 21, 22, 90, 92, 120, 131], "dft": [4, 5, 6, 7, 8, 16, 18, 19, 21, 23, 43, 67, 76, 81, 89, 90, 98, 100, 102, 122, 128, 139, 141, 142, 149], "contrast": [4, 16, 20, 22, 34, 49, 98, 120, 143, 147], "accommod": [4, 31, 38, 143], "descript": [4, 5, 19, 23, 27, 32, 39, 43, 47, 67, 72, 90, 94, 101, 121, 122, 125, 128, 143, 149, 153], "incept": 5, "1964": [5, 16, 67, 156], "hk64": [5, 16, 67], "obscur": [5, 43], "physic": [5, 11, 19, 20, 33, 38, 47, 53, 67, 72, 82, 91, 94, 113, 120, 122, 129, 140, 143, 144, 150], "approach": [5, 8, 15, 17, 20, 21, 22, 35, 43, 46, 47, 52, 55, 60, 64, 67, 68, 71, 72, 78, 80, 82, 99, 100, 106, 109, 111, 115, 117, 122, 123, 124, 141, 142, 143, 145, 148, 149], "solid": [5, 19, 67, 76, 82], "applic": [5, 9, 14, 16, 19, 53, 67, 88, 93, 99, 101, 113, 118, 141], "develop": [5, 19, 20, 43, 53, 54, 67, 91, 98, 103, 106, 143, 144, 153], "foundat": [5, 16, 82, 104, 129, 143], "establish": [5, 128, 149], "nevertheless": [5, 19, 91, 142, 143, 144, 149], "remain": [5, 15, 16, 18, 21, 43, 53, 55, 60, 66, 69, 91, 122, 143, 148, 149], "evolv": [5, 159], "research": [5, 43, 53], "area": [5, 142, 150, 151], "unresolv": 5, "question": [5, 43, 60, 143], "symmetri": [5, 19, 20, 29, 31, 41, 46, 47, 56, 65, 67, 74, 76, 82, 84, 91, 102, 143], "dilemma": 5, "gorling93": [5, 67], "novel": [5, 43], "cmsy12": [5, 67], "attempt": [5, 16, 19, 20, 42, 92, 144, 149], "were": [5, 16, 19, 20, 21, 43, 65, 72, 82, 90, 101, 105, 113, 120, 153], "rather": [5, 18, 20, 21, 41, 46, 49, 60, 70, 76, 90, 98, 122, 143, 144, 148, 149], "disappoint": [5, 21, 101], "poor": [5, 14, 19, 21, 62, 144, 149], "success": [5, 27, 36, 50, 61, 66, 149], "late": [5, 19], "1980": [5, 19, 67], "immedi": [5, 11, 46, 72, 82, 102, 133], "attent": [5, 19, 91], "breakthrough": 5, "becam": [5, 19], "mainli": [5, 74, 124, 129, 143, 144], "capabl": [5, 7, 19, 43, 53, 128, 144, 149], "later": [5, 10, 21, 33, 70, 83, 142], "rapid": [5, 43], "popular": [5, 19, 21], "situat": [5, 15, 19, 21, 25, 33, 34, 73, 82, 96, 101, 120, 122, 128, 144, 149], "wide": [5, 12, 19, 43, 74, 91, 101, 109, 122], "wa": [5, 16, 19, 21, 35, 42, 47, 49, 53, 55, 70, 72, 73, 82, 90, 99, 101, 113, 122], "inher": [5, 19], "via": [5, 19, 43, 46, 68, 73], "inexpens": [5, 38], "featur": [5, 27, 69, 124, 125, 126, 133, 139, 141, 142, 143, 144, 146, 148, 149, 151, 158], "accuraci": [5, 6, 7, 12, 18, 19, 27, 46, 47, 52, 67, 91, 96, 101, 136, 143, 144], "sophist": [5, 149], "inito": 5, "hohenberg": [5, 67], "theorem": [5, 20, 21, 46, 75, 84, 111, 143, 146], "resembl": [5, 7, 61], "scf": [5, 6, 10, 18, 20, 21, 25, 33, 38, 40, 43, 46, 47, 49, 52, 59, 61, 67, 70, 72, 83, 100, 102, 108, 113, 115, 120, 122, 124, 125, 132, 136, 139, 142, 143, 145, 146, 148, 149, 151, 153, 157], "ast": [6, 7, 24, 25, 28, 88, 97, 106, 111, 113, 117, 142, 146, 150], "d_alpha": [6, 13, 18, 24, 28, 33, 38, 39, 83], "d_beta": [6, 13, 18, 24, 28, 33, 83], "observ": [6, 15, 20, 65, 72, 74, 78, 82, 86, 89, 91, 96, 111, 113, 142, 143, 144, 148, 154], "scalar": [6, 25, 28, 76, 82, 89, 91, 94, 141, 144, 149], "omega": [6, 8, 11, 17, 25, 27, 28, 29, 38, 46, 47, 49, 61, 70, 71, 72, 73, 75, 76, 78, 82, 83, 84, 88, 89, 91, 94, 98, 99, 102, 106, 111, 113, 117, 130, 150, 151], "_i": [6, 14, 16, 18, 21, 25, 28, 29, 36, 40, 55, 60, 66, 70, 72, 82, 86, 88, 90, 91, 94, 97, 111], "perman": [6, 11, 40, 46, 67, 74, 82, 83, 84, 98, 111], "dipol": [6, 8, 11, 20, 40, 41, 43, 46, 47, 48, 49, 61, 66, 67, 70, 74, 75, 86, 88, 90, 91, 99, 100, 101, 102, 106, 111, 117, 120, 123, 124, 125, 130, 131, 141, 144, 148, 150], "moment": [6, 11, 20, 35, 41, 43, 46, 47, 48, 49, 61, 66, 67, 70, 72, 74, 75, 78, 82, 88, 90, 91, 94, 98, 99, 100, 101, 102, 111, 113, 117, 120, 123, 124, 125, 130, 131, 142, 144, 148, 150, 151], "_z": [6, 26, 31, 33, 82, 86], "evalu": [6, 8, 19, 28, 29, 36, 38, 46, 47, 55, 62, 67, 86, 103, 144], "techniqu": [6, 9, 15, 21, 43, 46, 48, 52, 60, 69, 83, 101, 113, 122, 133, 141, 144], "approx": [6, 7, 18, 25, 33, 46, 49, 60, 82, 98, 130], "w_g": [6, 7], "_g": [6, 7, 18, 122], "grid_level": [6, 7, 18, 65, 100, 144], "dftutil": [6, 18], "get_default_grid_level": [6, 18], "grid_drv": [6, 7, 18], "veloxchemlib": [6, 7, 18, 60, 70, 130, 131, 132, 156], "griddriv": [6, 7, 18], "set_level": [6, 7, 18], "molgrid": [6, 7, 18], "w_to_numpi": [6, 7, 18], "z_g": 6, "z_to_numpi": [6, 17, 18, 38, 39, 70, 75, 83, 86, 144], "xc_drv": [6, 7, 18], "xcintegr": [6, 7, 18], "chi_g": [6, 7, 18], "compute_gto_valu": [6, 7, 18], "bg": [6, 7, 18], "ag": [6, 7, 18], "n_g": [6, 18], "44687595": 6, "think": [6, 33, 131, 146, 149], "dipole_drv": [6, 17, 38, 39, 70, 75, 83, 86, 88, 113, 144], "electricdipoleintegralsdriv": [6, 17, 38, 39, 70, 75, 83, 86, 88, 113, 144], "dipole_mat": [6, 17, 38, 39, 70, 75, 83, 86, 88], "mu_z": [6, 17, 33, 39, 61, 76, 82, 83, 86, 89, 102, 105, 113], "44687507": 6, "agreement": [6, 10, 14, 22, 39, 47, 78, 86, 88, 89, 94, 115, 122, 124, 143, 144, 149], "counterpart": [7, 14], "contraint": 7, "eigenfuct": 7, "_j": [7, 14, 15, 16, 21, 25, 28, 55, 66, 72], "least": [7, 11, 20, 25, 49, 69, 72, 128, 141, 143, 149], "potenti": [7, 8, 16, 19, 20, 21, 34, 36, 39, 40, 41, 45, 46, 47, 49, 50, 51, 55, 56, 57, 58, 60, 64, 67, 68, 69, 70, 84, 91, 108, 120, 123, 125, 134, 141, 143, 144, 148, 149, 150], "pure": [7, 8, 25, 33, 39, 43, 82, 89, 90, 113, 120, 128, 149], "wherea": [7, 8, 11, 15, 27, 31, 46, 72, 74, 76, 82, 84, 91, 96, 105, 122], "hybrid": [7, 35, 43, 46, 49, 60, 67, 113], "made": [7, 16, 17, 27, 34, 38, 43, 46, 47, 49, 67, 76, 86, 88, 90, 91, 96, 148, 150], "accordingli": [7, 46, 143], "just": [7, 20, 47, 55, 65, 70, 75, 84, 89, 91, 100, 113, 124, 133, 142, 143, 147, 149], "assumpt": [7, 14, 21], "mere": [7, 14, 25, 136, 149], "varepsilon_": [7, 15, 18, 19, 22, 31, 33, 49, 70, 72, 91], "lda": [7, 46], "phi_i": [7, 11, 28, 30, 46, 72, 94, 108, 144], "number_of_electron": [7, 13, 33], "34363816": 7, "conv_thresh": [7, 14, 21, 33, 39, 60, 65, 70, 72, 100, 106, 124, 131, 142, 144, 148, 151, 153], "7f": [7, 47, 130, 131, 132, 156], "1874344": 7, "overlap_drv": [7, 14, 17, 39], "overlapintegralsdriv": [7, 14, 17, 39], "hamiltonian": [7, 11, 14, 15, 16, 21, 22, 26, 27, 31, 35, 39, 46, 68, 70, 72, 73, 75, 78, 80, 82, 83, 88, 96, 99, 100, 111, 143, 149], "c1dii": [7, 14], "f_mat": [7, 14], "e_vec": [7, 14, 21, 39], "build": [7, 14, 17, 42, 43, 70, 71, 72, 76, 89, 91, 98, 140, 143, 144, 145, 147, 148], "inv": [7, 14, 38, 60, 86, 106, 113, 148], "f_dii": [7, 14], "contrbut": 7, "lda_exchang": 7, "e_xc": 7, "v_xc": 7, "f_xc": 7, "max_it": [7, 14, 21, 33, 39, 60, 100], "50": [7, 8, 14, 20, 27, 28, 38, 39, 41, 60, 62, 70, 72, 75, 81, 83, 90, 100, 101, 105, 113, 120, 122, 124, 125, 130, 131, 132, 143, 144, 148, 156], "core": [7, 14, 18, 22, 25, 43, 46, 67, 68, 72, 86, 104, 126, 141, 142, 144, 145, 146, 149], "ik": [7, 10, 14, 21, 39, 46, 66, 72, 82], "jk": [7, 14, 21, 33, 39, 46, 49, 72], "ijkl": [7, 14, 21, 39, 46], "comparison": [7, 10, 20, 33, 60, 67, 68, 70, 89, 96, 143, 144, 146, 149], "ilkj": [7, 14, 21, 39], "e_exact_exchang": 7, "metric": [7, 14, 39, 113], "e_mat": [7, 14], "multi_dot": [7, 14, 33, 52, 70], "reshap": [7, 14, 21, 33, 38, 39, 52, 70, 94, 130, 131, 132, 156], "67": [7, 67, 76, 101, 120, 122, 124, 125, 143, 144, 148, 156], "80508830": 7, "89381306": 7, "93847705": 7, "14e": [7, 21, 89], "66": [7, 20, 89, 101, 120, 122, 143, 148, 156], "26792219": 7, "28078058": 7, "13537283": 7, "19e": [7, 72, 76], "99359878": 7, "76615742": 7, "60690061": 7, "13e": 7, "12110246": 7, "90554682": 7, "73394901": 7, "65e": 7, "13715465": 7, "92293008": 7, "75103380": 7, "94e": [7, 72], "16585462": 7, "99147909": 7, "82023741": 7, "22e": [7, 72], "18739992": 7, "11598421": 7, "94844153": 7, "24e": 7, "18742612": 7, "11619778": 7, "94863105": 7, "35e": [7, 14, 72], "18743428": 7, "11849075": 7, "95101979": 7, "61e": [7, 72, 76], "18743440": 7, "11879444": 7, "95133716": 7, "63e": [7, 72], "11879427": 7, "95133701": 7, "68e": [7, 72, 98], "83": [7, 20, 70, 72, 89, 120, 125, 143, 156], "harte": 7, "phi_j": [7, 72, 86], "cancel": [7, 15, 19, 29, 46, 55, 101, 143, 149], "classic": [7, 19, 36, 37, 39, 55, 61, 68, 72, 76, 91, 100, 150], "longer": [7, 21, 33, 46, 47, 49, 103, 122, 143], "guarante": [7, 14, 60, 120], "varepsilon": [7, 10, 15], "f_xc_ii": 7, "k_ii": 7, "g_iiii": 7, "abcd": [7, 17, 22, 25, 150], "lda_x_ii": 7, "hf_x_ii": 7, "scatter": [7, 14, 18, 60, 61, 67, 88, 89, 91, 94, 103, 113, 129, 132, 141], "fontsiz": [7, 105, 143], "sie": [7, 143, 144], "percentag": [7, 126], "exce": [7, 60], "97": [7, 41, 44, 67, 70, 101, 124, 125, 143, 148, 156], "1f": [7, 47, 81, 136, 150], "62": [7, 20, 28, 90, 100, 101, 120, 122, 124, 131, 143, 156], "73": [7, 14, 20, 39, 67, 90, 101, 120, 125, 143, 144, 156], "outer": [7, 20, 47, 143, 144, 149], "valenc": [7, 26, 45, 67, 68, 72, 90, 104, 123, 126, 141, 149, 151, 153], "substanti": [7, 39, 47, 62, 141, 145, 149, 157], "inner": [7, 143, 149], "86": [7, 20, 101, 120, 131, 143, 156], "87": [7, 20, 62, 70, 89, 90, 101, 120, 124, 143, 156], "98": [7, 67, 70, 76, 89, 98, 100, 120, 122, 125, 148, 156], "neutral": [8, 84, 143, 144, 145], "nonpolar": 8, "suffici": [8, 16, 42, 47, 76, 98, 111, 117, 124, 143, 148, 149], "known": [8, 15, 22, 25, 26, 27, 29, 30, 36, 45, 46, 55, 74, 76, 78, 82, 88, 89, 91, 98, 99, 100, 108, 111, 122, 144], "van": [8, 18, 19, 34, 36, 67], "der": [8, 18, 19, 34, 36], "waal": [8, 18, 19, 34, 36], "prototyp": [8, 43, 144], "exemplifi": [8, 11, 45, 47], "2e_": 8, "interatom": [8, 38, 47, 153], "mp2": [8, 21, 43, 49, 67, 72, 139, 143, 144, 145, 146, 148], "au2ang": [8, 18], "529177": [8, 120], "atom_xyz": 8, "dimer_separ": 8, "atom_basi": 8, "aug": [8, 18, 26, 78, 128, 144, 149], "dimer_basi": 8, "hf_atom_energi": 8, "mp2_atom_energi": 8, "hf_dimer_energi": 8, "mp2_dimer_energi": 8, "dist": [8, 20, 21, 52, 120, 153], "micro": 8, "hf_interaction_energi": 8, "mp2_interaction_energi": 8, "1000": [8, 47, 60, 76, 98, 100, 130, 143, 150, 156], "1e6": 8, "interpol": [8, 47, 58, 67, 113, 124, 144], "e_h": [8, 150], "minimum": [8, 45, 46, 50, 57, 60, 92, 122, 133], "lack": [8, 19, 20, 21, 22, 89, 90, 143, 144, 149], "r_0": [8, 47, 100], "inset": 8, "below": [8, 11, 18, 21, 30, 33, 42, 45, 47, 60, 62, 69, 70, 72, 73, 82, 89, 91, 94, 101, 102, 105, 108, 122, 124, 131, 133, 141, 142, 143, 144, 146, 148, 157], "concern": [8, 11, 25, 56, 67, 72, 88, 91, 96, 136, 141, 148, 149], "_1": [8, 11, 15, 16, 22, 25, 28, 30, 38, 66, 97, 123, 150], "circ": [8, 47, 74], "fluctuat": 8, "induc": [8, 40, 46, 47, 67, 74, 76, 82, 88, 91, 99, 102], "weakli": [8, 19, 105], "randomli": [8, 61, 67, 74, 82], "orient": [8, 61, 67, 74, 76, 89, 100, 133, 142], "casimir": 8, "polder": 8, "eqnarrai": [8, 17, 29, 76, 82, 89, 91, 98, 99, 117], "hbar": [8, 16, 19, 25, 31, 38, 61, 70, 73, 75, 78, 82, 99, 100, 111, 117, 122, 150], "int_": [8, 82, 151], "infti": [8, 16, 22, 27, 55, 89, 91, 151], "_a": [8, 21, 25, 27, 36, 38, 39, 52, 72, 86, 88, 90, 97], "_b": [8, 21, 25, 27, 38, 72, 86], "nonumb": [8, 46, 60, 72, 91], "quad": [8, 11, 14, 15, 16, 22, 26, 27, 31, 46, 70, 72, 94, 113], "intermolecular": [8, 67, 91, 105, 153], "speed": [8, 46, 55, 66, 82, 91, 150], "isotrop": [8, 20, 74, 75, 84, 117, 142, 144], "electr": [8, 33, 38, 39, 46, 49, 61, 67, 74, 78, 81, 83, 86, 96, 99, 102, 106, 111, 141, 148, 150], "polariz": [8, 35, 37, 46, 48, 49, 61, 66, 67, 74, 75, 76, 78, 88, 91, 98, 99, 111, 131, 132, 150], "imaginari": [8, 60, 65, 76, 86, 89, 98, 113, 124, 142, 144], "frequenc": [8, 43, 50, 55, 61, 73, 76, 78, 82, 83, 86, 88, 89, 91, 96, 98, 99, 113, 117, 124, 130, 131, 132, 142, 144, 150, 156], "entiti": [8, 11, 53], "addit": [8, 15, 16, 20, 21, 25, 29, 33, 40, 41, 46, 49, 55, 69, 75, 78, 89, 91, 122, 128, 141, 142, 143, 144, 149, 157], "multipol": [8, 47, 74, 91, 141], "magnet": [8, 20, 31, 46, 70, 74, 76, 81, 82, 89, 91, 98, 99, 102, 111, 120, 122, 125, 143, 148], "c_m": 8, "ldot": [8, 22, 25, 26, 28, 29, 30, 31, 46, 66, 72, 73, 74, 82, 86, 88, 94, 97, 113, 150], "k_n": 8, "c_6": [8, 9], "c_8": 8, "cdot": [8, 11, 14, 15, 16, 19, 22, 25, 28, 29, 30, 36, 55, 74, 82, 83, 86, 88, 89, 91, 94, 99, 100, 111], "k_7": 8, "k_9": 8, "london": [8, 47, 67], "finit": [8, 46, 48, 73, 84, 100, 113], "photon": [8, 69, 70, 73, 91, 99, 111, 123, 129, 130, 141, 144, 148, 150], "mediat": 8, "electromagnet": [8, 25, 46, 69, 74, 82, 88, 89, 99, 102, 103, 111, 129, 130], "retard": 8, "c6_drv": 8, "c6driver": 8, "c6_result": 8, "hf_c6": 8, "c6": 8, "realist": [8, 55], "navi": [8, 58, 70], "axhlin": [8, 14, 20, 101, 113, 120, 157], "28": [8, 14, 20, 24, 26, 28, 65, 70, 90, 98, 100, 101, 120, 122, 143, 148, 156], "34": [8, 20, 44, 65, 88, 90, 100, 101, 113, 120, 143, 150, 156], "bind": [8, 43, 59, 67, 69, 143, 144], "29": [8, 14, 20, 47, 70, 98, 100, 101, 120, 122, 124, 125, 143, 148, 150, 156], "equilibrium": [8, 20, 21, 33, 47, 52, 55, 60, 62, 66, 100, 124, 136, 155], "96": [8, 20, 67, 70, 90, 120, 124, 125, 143, 148, 156], "vvlvd90": [8, 67], "depict": [8, 72, 73], "cross": [8, 43, 47, 61, 66, 67, 70, 82, 92, 117, 123, 124, 130, 142, 144, 150], "vertic": [8, 60, 70, 72, 124, 144], "horizont": 8, "quit": [8, 19, 27, 55, 60, 83, 89, 98, 99, 111, 113, 133, 143, 144, 148, 149, 153, 157], "procedur": [8, 12, 14, 17, 27, 40, 46, 49, 60, 68, 72, 76, 82, 89, 98, 122, 148], "inclus": [8, 19, 21, 75, 125, 141, 147, 149], "nonbond": [8, 47], "introduct": [9, 16, 19, 32, 41, 56, 67, 101], "visual": [9, 12, 18, 21, 43, 59, 60, 62, 67, 70, 92, 96, 105, 113, 120, 123, 126, 130, 131, 133, 139, 140, 142, 143, 145, 152, 154, 155, 156, 157, 158, 159], "collinear": [9, 26, 31, 76], "noncollinear": [9, 31], "dispers": [9, 19, 35, 47, 67, 74, 144], "demonstr": [9, 16, 22, 75, 152], "rayleigh": [9, 22, 89, 129], "formal": [9, 17, 46, 67, 70, 91], "group": [9, 19, 34, 36, 41, 43, 47, 56, 82, 84, 91, 102, 130, 133], "canon": [10, 19, 31, 94, 105, 125, 153, 157], "matric": [10, 13, 14, 17, 21, 28, 29, 31, 33, 46, 49, 61, 67, 71, 72, 73, 76, 82, 94, 98, 111, 113, 139, 143, 144, 148, 153], "f_alpha": [10, 13], "against": [10, 17, 28, 96, 100, 149], "own": [10, 33, 42, 43, 55, 62, 101], "5482": [10, 156], "3452": 10, "7058": [10, 156], "5711": 10, "4946": 10, "perfect": [10, 14, 22, 39, 86, 88, 94, 115, 148], "duplic": 10, "extend": [10, 21, 43, 55, 82, 89, 91, 92, 98, 133, 144], "row": [10, 11, 26, 38, 45, 66, 82, 91, 94, 141, 143, 149], "s_ext": 10, "f_ext": 10, "encount": [10, 82, 89], "except": [10, 42, 46, 61, 72, 89, 117, 120, 143], "address": [10, 19, 43, 60, 111, 122, 123, 128, 143, 144, 149], "symmetr": [10, 11, 16, 21, 30, 33, 46, 47, 61, 70, 72, 76, 84, 89, 98, 102, 117, 122, 130, 141], "unitari": [10, 11, 15, 24, 67, 72, 94, 97, 113], "sigma_ext": 10, "u_ext": 10, "isclos": 10, "thereaft": [10, 38, 88, 94], "detect": [10, 76, 82, 120], "degeneraci": [10, 31, 141, 142, 143], "rectangular": [10, 45, 52, 94], "retriev": [10, 13, 25, 26, 39, 100, 113, 115, 133], "oao": 10, "chi": [10, 18, 26, 38, 41, 47, 91, 150], "straightforward": [10, 11, 21, 31, 45, 49, 68, 82, 86, 93, 99, 111, 113, 142, 143, 144], "readili": [10, 15, 26, 43, 82], "satisfi": [10, 16, 21, 46, 71], "sqrt": [10, 15, 18, 19, 20, 30, 31, 38, 55, 66, 70, 80, 86, 88, 89, 94, 96, 97, 106, 113, 122, 148, 151], "f_oao": 10, "ki": [10, 15, 39, 46, 66, 72, 82], "lj": [10, 39, 46, 47, 72], "c_oao": 10, "phi": [10, 22, 24, 25, 26, 30, 31, 38, 82, 84, 94, 96, 97, 100, 108, 150], "identifi": [10, 11, 28, 38, 45, 46, 56, 62, 70, 82, 83, 88, 97, 99, 100, 102, 111, 143, 144, 149], "kj": [10, 33, 46, 47, 62, 66, 72, 150], "everydai": [11, 74], "life": [11, 74, 151], "invers": [11, 20, 27, 45, 52, 60, 63, 66, 70, 82, 91, 113, 120, 125, 130, 143, 148, 150], "unchang": [11, 15, 63], "mechan": [11, 25, 35, 36, 39, 41, 45, 47, 51, 52, 53, 61, 64, 67, 74, 99, 102, 111, 151], "distinguish": [11, 15, 20, 74], "former": [11, 15, 19, 22, 38, 46, 100, 141, 144], "latter": [11, 16, 19, 31, 33, 46, 49, 58, 70, 74, 78, 84, 139, 143, 144, 149], "frame": [11, 65, 70, 74, 89, 130, 131, 132, 156], "sequenc": [11, 14, 67, 73, 76, 82, 98, 100], "map": [11, 16, 29, 108], "spectrum": [11, 18, 61, 67, 69, 99, 100, 102, 103, 106, 113, 124, 129, 130, 131, 134, 141, 143, 145, 148, 156, 158, 159], "intens": [11, 48, 49, 66, 67, 70, 72, 76, 81, 91, 96, 99, 102, 104, 106, 111, 124, 125, 130, 132, 143, 144, 146, 148, 149, 153, 156], "sigma_": [11, 102], "leftarrow": [11, 82, 102], "propto": [11, 74, 91, 102, 144], "psi_f": [11, 78, 94, 102], "psi_i": [11, 15, 19, 28, 72, 80, 102], "must": [11, 46, 55, 60, 64, 70, 82, 130, 131, 132, 142], "split": [11, 31, 33, 47, 102, 125, 141, 142, 143, 149, 153, 156, 159], "0pt": [11, 25, 28, 113], "14pt": 11, "spatial": [11, 15, 16, 18, 24, 25, 26, 29, 31, 33, 70, 91, 97, 113, 142, 143, 150], "action": [11, 29, 43, 74, 150], "commut": [11, 29, 31, 78, 88, 113], "therebi": [11, 15, 18, 22, 27], "fulfil": [11, 16, 21, 27, 38, 55, 84, 117, 143], "member": 11, "law": [11, 47, 55, 91, 150], "belong": [11, 82, 102, 153], "ourselv": [11, 49], "geometr": [11, 47, 52, 60, 65, 66, 67, 99, 111, 117, 130, 153], "plane": [11, 31, 47, 74, 82, 120, 142, 144], "everi": [11, 21, 26, 43, 49, 82, 100, 101, 108, 122], "crystal": 11, "possess": [11, 74, 142, 143, 144], "translat": [11, 20, 43, 46, 60, 67, 69, 97, 130], "noth": 11, "_n": [11, 14, 15, 16, 22, 25, 27, 28, 30, 46, 70, 72, 97, 136], "princip": [11, 66, 111], "perpendicular": [11, 61, 74, 76, 82, 89, 98], "_h": [11, 76, 91, 98], "_v": [11, 21], "bisect": 11, "c_2": 11, "_d": 11, "invert": [11, 20, 45], "through": [11, 17, 22, 42, 43, 46, 47, 52, 55, 70, 72, 73, 74, 76, 91, 96, 108, 111, 113, 117, 123, 130, 131, 132, 133, 143, 144, 156, 157, 159], "improp": [11, 47, 74, 82], "rotoreflect": 11, "flowchart": 11, "knowledg": [11, 16, 55, 108, 122], "regard": [11, 70, 72, 73], "asymmetr": [11, 130, 151], "distribut": [11, 20, 26, 31, 35, 36, 42, 43, 47, 55, 71, 84, 143, 149, 151], "c_n": [11, 28], "moreov": [11, 12, 25, 82, 105, 115], "nv": 11, "superimpos": [11, 74], "mirror": [11, 74], "imag": [11, 67, 74, 86, 113, 120, 124, 133, 142, 144, 159], "said": [11, 31, 74, 91], "chiral": [11, 67, 74, 82], "inabl": [11, 19], "direct": [11, 17, 20, 26, 29, 33, 39, 49, 60, 64, 67, 70, 72, 73, 74, 82, 88, 91, 96, 98, 102, 117, 118, 120, 122, 125, 142, 143, 148], "enantiom": [11, 74], "s_n": 11, "presenc": [11, 22, 33, 46, 49, 55, 69, 74, 82, 83, 84, 89, 96, 120], "irreduc": [11, 102], "irrep": 11, "abelian": 11, "xz": [11, 17, 31, 38, 61, 89, 142], "yz": [11, 17, 38, 61, 89, 142], "a_1": [11, 74], "a_": [11, 36, 41, 46, 82, 86, 91, 106, 113, 150], "r_z": [11, 82], "r_y": [11, 102], "r_x": [11, 82], "a_g": [11, 102], "xy": [11, 17, 31, 38, 52, 61, 89, 120, 142], "1g": 11, "2g": [11, 102], "1u": 11, "2u": 11, "3u": [11, 102], "gamma": [11, 15, 17, 21, 24, 31, 33, 46, 47, 60, 61, 70, 71, 74, 75, 76, 81, 83, 91, 98, 102, 105, 106, 113, 117, 124, 125, 143, 144, 148, 151], "psi": [11, 15, 16, 22, 24, 25, 26, 27, 28, 30, 31, 46, 70, 72, 82, 88, 90, 96, 97, 99, 100, 111, 150], "psi_1": [11, 19, 25, 29, 97, 150], "otim": [11, 25, 26, 27, 30, 91, 102], "psi_2": [11, 19, 29, 97], "psi_n": [11, 19, 25, 70, 72, 73, 150], "variat": [12, 15, 16, 20, 25, 36, 41, 46, 49, 67, 78, 86, 97, 99, 102, 143], "sens": [12, 16, 27, 97], "cornerston": 12, "underli": [12, 19, 25, 26, 43, 68, 104, 105, 108], "mol_xyz": [13, 81], "number_of_atom": [13, 38, 52, 130, 131, 132, 153, 156], "10f": [13, 22, 153], "0265782198": 13, "dictionari": [13, 33, 62, 100, 113, 131, 150], "norbit": 13, "eri_thresh": 13, "qq_type": 13, "c_beta": [13, 24], "e_beta": 13, "f_beta": 13, "55119961": 13, "33473347": 13, "69692651": 13, "56605275": 13, "49289827": 13, "18486487": 13, "25566978": 13, "78604709": 13, "85103488": 13, "16387193": 13, "20030818": 13, "25366153": 13, "44422793": 13, "4755769": 13, "67329727": 13, "8679223": 13, "93111284": 13, "4430781": 13, "48048696": 13, "28268216": 13, "334531": 13, "50569214": 13, "86065795": 13, "14355137": 13, "static": [13, 23, 38, 46, 49, 74, 76, 83, 84, 89, 96, 98, 99, 102, 111, 121, 128, 147, 149, 155, 157], "html": [13, 42, 43, 102, 153, 157], "download": [13, 42, 43, 92], "lab": [13, 42], "view": [13, 18, 19, 25, 39, 47, 59, 60, 62, 65, 70, 82, 86, 90, 92, 94, 102, 124, 130, 131, 132, 133, 136, 137, 139, 148, 154, 156, 157, 159], "pull": [13, 39, 98, 102], "02698419": 14, "12f": [14, 25, 33], "343638157670": 14, "dure": [14, 19, 20, 21, 33, 52, 58, 65, 92, 120, 122, 131, 156], "unintuit": 14, "bmatrix": [14, 45, 94, 97, 113], "f_": [14, 15, 16, 21, 46, 49, 70, 71, 72, 76, 80, 83, 84, 86, 89, 106, 111, 113], "ov": [14, 17, 22, 33, 38, 72, 86, 97], "vo": [14, 33, 38, 67, 97], "vanish": [14, 15, 29, 38, 46, 48, 50, 60, 64, 65, 66, 70, 74, 82, 84, 91, 117], "error_rh": 14, "68": [14, 20, 24, 26, 65, 120, 122, 143, 156], "84975229": 14, "09e": [14, 72, 89], "69": [14, 20, 60, 101, 120, 124, 143, 153, 156], "95937641": 14, "88e": [14, 89], "34743276": 14, "83e": [14, 72], "46688910": 14, "23e": [14, 72], "74058933": 14, "18e": [14, 72, 76], "55859127": 14, "41e": [14, 148], "86908635": 14, "26e": [14, 72], "97444165": 14, "82e": [14, 21, 72, 76, 89, 148], "00992921": 14, "74e": [14, 72], "02143957": 14, "57e": [14, 72], "02519173": 14, "89e": [14, 21, 72, 89], "02640379": 14, "06e": [14, 72], "02679653": 14, "02692347": 14, "64e": [14, 72, 89], "02696455": 14, "31e": 14, "02697784": 14, "30e": 14, "02698213": 14, "01e": [14, 21, 72, 89, 148], "17": [14, 19, 20, 21, 25, 26, 62, 65, 67, 72, 80, 86, 89, 90, 98, 99, 100, 101, 120, 122, 124, 125, 129, 143, 150, 156], "02698352": 14, "71e": [14, 21, 72, 89], "02698397": 14, "19": [14, 17, 19, 22, 24, 25, 58, 65, 67, 70, 89, 90, 100, 101, 113, 120, 122, 124, 125, 131, 143, 144, 145, 148, 149, 150, 156], "02698412": 14, "54e": [14, 21], "02698416": 14, "15e": [14, 72], "02698418": 14, "79e": 14, "22": [14, 28, 62, 67, 70, 89, 90, 92, 101, 120, 122, 124, 125, 142, 143, 144, 156], "02e": [14, 21], "23": [14, 20, 24, 65, 70, 90, 101, 120, 122, 124, 125, 143, 148, 156], "80e": 14, "07e": [14, 72], "45e": [14, 89], "96e": [14, 72], "12e": [14, 89], "07": [14, 20, 31, 70, 72, 75, 76, 90, 94, 101, 120, 124, 125, 143], "rothaan": 14, "hall": 14, "suffer": [14, 18, 20, 22, 46, 72], "pul80": [14, 67], "pul82": [14, 67], "sel93": [14, 67], "w_i": [14, 18], "preserv": [14, 16, 38, 97, 143], "impos": [14, 46, 100, 144], "condit": [14, 16, 46, 49, 66, 71, 82, 86, 89, 91, 117], "strict": [14, 16], "strictli": [14, 142], "w_j": 14, "constrain": [14, 15, 16, 46, 47, 64, 153], "lagrang": [14, 15, 16, 38, 41, 46, 67], "convent": [14, 15, 82, 96, 102, 111, 113, 150], "arriv": [14, 15, 25, 26, 38, 60, 82, 86, 100, 150], "pmatrix": [14, 15, 25, 26, 28, 30, 31, 36, 38, 45, 46, 71, 82, 86, 88, 94, 97, 99, 113], "1n": 14, "vdot": [14, 15, 28, 30, 36, 81, 94], "ddot": [14, 15, 28, 30, 36, 94], "n1": 14, "w_1": 14, "w_n": 14, "modif": [14, 38, 101], "But": [14, 16, 20, 21, 43, 46, 120], "extra": [14, 92, 143, 149], "hamper": [14, 16], "optimum": 14, "stabilit": 14, "error_dii": 14, "88501761": 14, "37e": [14, 89], "97016719": 14, "01483442": 14, "34e": [14, 89], "02676704": 14, "29e": [14, 21, 72, 98], "02698021": 14, "32e": [14, 72], "02698392": 14, "04e": 14, "97e": 14, "43e": [14, 72, 76], "roothaan": 14, "yscale": [14, 18], "log": [14, 18, 65, 151], "linestyl": [14, 20, 99, 106, 120, 148], "grei": [14, 99], "frameon": [14, 58, 96, 157], "vmatrix": [15, 30], "min_": [15, 16], "ji": [15, 25, 46, 52, 86], "psi_j": [15, 28, 72, 80, 86], "search": [15, 16, 43, 48, 60, 64, 108], "mbox": [15, 84, 113], "varepsilon_0": [15, 16, 19, 25, 36, 39, 41, 82, 150], "psi_k": [15, 25, 72, 100], "overal": [15, 21, 30, 31, 38, 88, 97], "among": [15, 19, 43, 48, 88, 97], "emploi": [15, 17, 19, 46, 48, 49, 78, 91, 94, 100, 144], "lcao": [15, 26, 38, 46], "alpha_": [15, 38, 61, 75, 76, 82, 83, 88, 89, 91, 111, 113], "beta_": [15, 24, 76, 83, 91, 98, 144], "tr": [15, 38, 70], "varepsilon_i": [15, 19, 33, 49, 70, 72, 86], "varepsilon_a": [15, 33, 49, 70, 72, 86], "ioniz": [15, 67, 68, 106, 141, 144, 145, 146], "ie": [15, 143, 144, 145, 146, 148], "affin": [15, 68, 144], "ea": [15, 84, 99], "e_i": [15, 80, 82], "e_a": [15, 39, 52, 99], "frozen": [15, 31, 41, 58, 75, 82, 143], "excit": [15, 18, 19, 21, 22, 26, 27, 29, 33, 38, 43, 51, 52, 67, 68, 69, 71, 73, 75, 78, 80, 89, 90, 92, 93, 94, 96, 98, 99, 100, 101, 102, 103, 104, 105, 106, 115, 117, 118, 120, 122, 123, 124, 125, 128, 129, 130, 141, 142, 144, 145, 146, 147, 149, 151, 158], "summat": [15, 17, 24, 25, 28, 38, 73, 82, 88, 91, 96, 97, 111, 117], "customari": [15, 21], "compon": [15, 16, 19, 22, 25, 26, 27, 31, 33, 38, 40, 43, 46, 49, 61, 67, 70, 74, 75, 76, 81, 82, 84, 88, 91, 96, 98, 100, 122, 125, 131, 142, 143, 144, 150], "isol": [16, 39, 80, 83, 88, 99, 111], "psi_0": [16, 70, 72, 73, 78, 80, 94], "eq": [16, 19, 46, 49, 61, 66, 72], "sch": 16, "e_0": [16, 27, 33, 46, 70, 72, 73, 82, 83, 111], "extern": [16, 31, 33, 38, 40, 43, 46, 49, 74, 78, 82, 83, 86, 88, 91, 96, 100, 102, 103, 111], "nabla_i": 16, "z_k": [16, 61, 84], "_k": [16, 61, 66], "proton": [16, 150], "task": [16, 43, 55, 88, 140, 144], "n_0": 16, "cartesian": [16, 31, 38, 49, 56, 60, 61, 82, 88, 91, 96, 125, 142, 150], "1920": [16, 156], "thoma": 16, "fermi": [16, 21, 28, 120, 150], "legitim": 16, "tild": [16, 25, 36, 46, 60, 66, 70, 72, 76, 89, 96, 97], "uniqu": [16, 29, 36, 38, 45, 82, 100, 143, 144, 153], "univers": [16, 34, 67], "undefin": 16, "geq": 16, "detemin": 16, "leq": [16, 46], "prohibit": 16, "theoret": [16, 43, 67, 76, 91, 103, 123, 129, 144], "still": [16, 20, 21, 47, 62, 66, 82, 92, 101, 120, 133, 144, 148, 149], "recip": 16, "reformul": [16, 99, 143], "wider": 16, "nabla": [16, 18, 19, 25, 60, 82, 84, 91, 108, 150], "levi": [16, 31, 67], "deliv": [16, 82], "lev79": [16, 67], "stationari": [16, 36, 38, 45, 46, 47, 50, 60, 91, 103], "altern": [16, 17, 19, 21, 31, 49, 62, 73, 91, 100, 113, 124, 133, 142, 143, 144, 148, 149, 159], "angular": [17, 26, 31, 61, 73, 76, 82, 88, 89, 91, 96, 98, 100, 128, 130], "m_l": [17, 26], "get_dimension_of_basi": [17, 22, 86, 88, 94, 96, 115], "h_1": [17, 90, 101, 124], "h_2": 17, "2p_y": 17, "3p_y": 17, "2p_z": 17, "3p_z": 17, "2p_x": 17, "3p_x": 17, "3d_": 17, "expos": [17, 99, 103], "linmom_drv": 17, "linearmomentumintegralsdriv": 17, "linmom_mat": 17, "p_x": [17, 143], "x_to_numpi": [17, 18, 39, 70, 75, 83, 88, 113, 144], "p_y": 17, "y_to_numpi": [17, 18, 39, 70, 75, 83, 144], "p_z": [17, 24, 78], "mu_x": [17, 33, 39, 61, 83, 88, 102, 105, 113], "mu_i": [17, 33, 39, 61, 66, 82, 83, 102, 105, 113], "angmom_drv": 17, "angularmomentumintegralsdriv": 17, "angmom_mat": 17, "m_x": [17, 102, 105], "m_y": [17, 102, 105], "m_z": [17, 102, 105], "omega_": [17, 25, 29, 46, 49, 61, 70, 73, 75, 76, 78, 82, 83, 88, 91, 98, 99, 100, 117, 130, 150], "mu_z_mo": 17, "deduc": [17, 73], "mu_z_ao": [17, 86], "bp": 17, "cq": 17, "forth": [17, 55, 94], "back": [17, 20, 43, 45, 55, 70, 73, 90, 123, 133, 153], "assert_allclos": [17, 28, 86], "atol": [17, 28, 86], "reli": [17, 73], "consum": [17, 47], "cost": [17, 47, 52, 60, 80, 89, 120, 128, 136, 139, 142, 143, 144, 149], "demand": [17, 55], "g_1": [17, 22], "abc": [17, 22], "g_2": [17, 22], "cr": [17, 22, 33, 120], "abr": [17, 22], "g_3": [17, 22], "aqr": [17, 22], "g_mo": 17, "eri": [17, 20, 25, 33, 70, 72, 76, 86, 89, 98, 113, 120, 125, 143, 148], "physicist": [17, 25, 29, 33, 46, 70, 72, 113, 150], "erimo_drv": [17, 22, 86], "mointegralsdriv": [17, 22, 25, 33, 70, 86, 113], "phys_oovv": [17, 70, 113], "oo": [17, 72, 86], "vv": [17, 72, 86], "chem_ovov": [17, 22, 70, 86], "swapax": 17, "ovov": [17, 22, 70, 86], "screen": [17, 20, 70, 72, 76, 89, 98, 120, 125, 143, 144, 148], "parallel": [17, 43, 61, 71, 73, 74, 76, 89, 98], "gator": [17, 42, 67, 70, 72, 124, 125, 142, 144, 145, 153], "d_ij": 17, "k_ij": 17, "acbd": 17, "g_ivjv": 17, "db": 17, "xc": [18, 19, 20, 46, 49, 80, 105, 106, 108, 113, 128, 136, 142, 143, 144], "log3": 18, "quadratur": [18, 67], "ta95": [18, 67], "ssf": 18, "partit": [18, 19, 29, 35, 46, 68, 70, 73], "ssf96": [18, 67], "amount": [18, 19, 20, 25, 43, 71, 105, 120, 143, 144, 149], "assess": [18, 67, 96], "creation": [18, 73, 97, 111, 141, 143, 144], "number_of_point": 18, "40720": [18, 76, 89, 98], "sphere": [18, 59, 70, 84, 90, 130, 131, 132, 133, 136, 137, 139, 154, 156, 159], "radiu": [18, 38, 47, 52, 60, 82, 100, 143, 150], "a_0": [18, 46, 74, 150], "grid_xyz": 18, "ngrid": 18, "52911721": 18, "insid": [18, 34, 41, 47, 90, 100], "5398": 18, "35322": 18, "Not": [18, 46, 89], "surprisingli": 18, "volum": [18, 28, 30, 34, 55, 67, 150], "400": [18, 59, 62, 65, 69, 92, 120, 124, 133, 136, 159], "addmodel": [18, 39, 59, 62, 65, 70, 90, 124, 130, 131, 132, 133, 136, 137, 139, 154, 156, 157, 159], "setstyl": [18, 39, 47, 59, 62, 65, 70, 90, 92, 124, 130, 131, 132, 133, 136, 137, 139, 154, 156, 157, 159], "stick": [18, 39, 47, 59, 62, 65, 70, 90, 92, 124, 130, 131, 132, 133, 136, 137, 139, 154, 156, 157, 159], "addsurfac": 18, "vdw": [18, 47], "opac": [18, 70, 157], "elem": [18, 159], "zoomto": [18, 59, 62, 65, 130, 131, 132, 133, 156], "radial": [18, 120, 143, 152], "maxima": [18, 120], "rad_dist": 18, "patch": [18, 60], "hist": 18, "bin": 18, "def2": [18, 26, 76, 81, 83, 88, 89, 96, 98, 120], "svpd": [18, 26, 76, 83, 89, 98], "vari": [18, 19, 47, 55, 96, 128, 143, 144, 149], "eight": [18, 102, 122], "107": [18, 67, 156], "900": [18, 113, 156], "n_grid_point": 18, "n_elec": 18, "4404": [18, 156], "10536": [18, 47], "20678": 18, "63844": 18, "147024": 18, "348468": 18, "1107906": 18, "ten": [18, 27, 29, 35, 143], "vare": 18, "ax1": [18, 20, 100, 124], "add_subplot": [18, 131], "111": [18, 65, 76, 156], "annot": [18, 99, 120], "gga": 18, "xytext": [18, 99], "arrowprop": [18, 99], "arrowstyl": 18, "set_xlim": [18, 20, 100, 124], "ax2": [18, 20, 100, 124], "twini": 18, "set_xticklabel": 18, "set_xlabel": [18, 20, 58, 59, 60, 100], "insensit": [18, 41, 144], "regoin": 18, "simul": [18, 43, 47, 53, 55, 67, 68, 70, 147], "spectroscopi": [18, 43, 48, 61, 66, 67, 69, 82, 93, 96, 102, 103, 113, 142, 143, 145, 146, 149, 150], "lock": 18, "four": [18, 19, 24, 29, 36, 39, 41, 46, 47, 65, 67, 71, 76, 80, 82, 97, 102, 124, 132, 133, 141, 143, 144, 148, 150, 151, 153], "frequent": [18, 19, 82, 101], "41": [18, 20, 24, 39, 65, 67, 72, 86, 89, 90, 91, 97, 101, 120, 122, 124, 125, 131, 143, 156], "fill_between": [18, 142], "get_xaxis_transform": 18, "85": [18, 20, 33, 70, 100, 120, 131, 143, 148, 156], "alik": 18, "occation": 18, "alarmingli": 18, "earli": 19, "led": [19, 20, 78, 91], "inaccur": 19, "1965": [19, 67, 156], "ks65": [19, 67], "propos": [19, 60], "correspondingli": [19, 91], "iint": 19, "act": [19, 25, 29, 39, 47, 55, 73, 90, 111], "conserv": [19, 36, 38, 43, 55, 67, 91, 117], "eff": [19, 20, 71, 72, 108], "unknown": [19, 46, 49, 60, 86], "justifi": [19, 115], "inaccuraci": 19, "classifi": [19, 38, 91, 100], "variou": [19, 43, 56, 70, 72, 91, 104, 123, 141, 142], "parameter": [19, 43, 90, 96, 111, 143], "argument": [19, 28, 88, 89], "categori": [19, 26, 35, 38], "type": [19, 43, 46, 47, 56, 58, 62, 70, 80, 81, 100, 120, 128, 129, 144, 149, 151, 153], "highlight": [19, 21, 82], "promin": 19, "assum": [19, 21, 25, 27, 38, 49, 64, 82, 89, 91, 94, 96, 98, 99, 111, 113, 132, 133, 154, 156], "implicitli": [19, 27, 46, 91, 96, 133], "understood": [19, 20, 27, 39, 82, 100, 113], "decompos": [19, 38, 61, 125, 142], "jacob": 19, "ladder": [19, 31, 67], "sole": [19, 82], "almost": [19, 20, 90, 126, 144, 148], "dirac": [19, 26, 28, 67], "dir30": [19, 67], "vosko": [19, 67], "wilk": [19, 67], "nussair": 19, "vwn80": [19, 67], "de": [19, 38, 46, 67, 73, 75, 83, 153], "facto": 19, "undertaken": 19, "sha71": [19, 67], "herman": [19, 67], "worker": 19, "hvdo69": [19, 67], "1970": 19, "unsuccess": 19, "1988": [19, 67], "reliabl": [19, 43, 67, 83, 98, 128, 149], "b88": [19, 143], "beck": [19, 67], "bec88": [19, 67], "notabl": 19, "lee": [19, 67], "yang": [19, 67], "parr": [19, 67], "lyp": [19, 143], "lyp88": [19, 67], "perdew": [19, 67], "burk": 19, "ernzerhof": [19, 67], "es99": [19, 67], "bec93": [19, 67], "sdcf94": [19, 67], "pursu": 19, "decad": [19, 91], "tao": [19, 67], "2003": [19, 67, 156], "staroverov": [19, 67], "scuseria": [19, 67], "tpss03": [19, 67], "truhlar": [19, 67], "zt11": [19, 67], "revis": [19, 67], "wjy": [19, 67], "incorpor": [19, 83], "vwn": [19, 143], "gold": 19, "besid": [19, 46], "minnesota": 19, "famili": [19, 26, 38, 128, 149], "consider": [19, 46, 47, 71, 144, 148], "short": [19, 20, 21, 35, 38, 43, 47, 53, 82, 91, 120, 133, 149], "asymptot": [19, 67, 80, 149], "behavior": [19, 53, 67, 80, 91], "optic": [19, 62, 67, 74, 82, 99, 111, 113], "cam": [19, 67, 98, 128, 149], "yth04": [19, 67], "initio": [19, 52, 67, 68, 80], "transfer": [19, 38, 47, 55, 67, 76, 80, 90, 97, 98, 104, 113, 128, 149, 153], "mention": [19, 21, 55, 96, 101], "recent": [19, 54, 142, 144], "year": 19, "empir": [19, 35, 43, 59], "strategi": [19, 21, 70, 73], "grimm": [19, 67], "ceh": [19, 67], "gaek10": [19, 67], "who": [19, 108], "d3": [19, 83], "d4": [19, 83], "successfulli": 19, "strongli": [19, 45, 105, 113, 143, 149], "viabl": [19, 125], "draw": 19, "built": [19, 38, 75, 124, 125, 143, 144], "treatment": [19, 53, 67, 72, 75, 144], "broken": [19, 20, 120], "simplic": [20, 82, 99, 101, 111, 122, 144], "textbook": [20, 43], "dissoci": [20, 21, 52, 92, 120], "angstrom": [20, 21, 33, 34, 36, 39, 41, 52, 92, 100, 120, 122, 131, 150, 153], "e_h_hf": [20, 21, 120], "e_h_blyp": 20, "cidrv": [20, 21, 75, 101], "e_h_fci": 20, "h2": [20, 31, 52, 120], "mol_templ": [20, 21, 33, 52, 120], "h2dist": 20, "dft_drv": 20, "distlist": [20, 21, 33, 52, 120], "65": [20, 47, 70, 76, 89, 91, 101, 120, 122, 143, 148, 156], "e_blyp": 20, "dft_result": [20, 144], "y1": [20, 60, 81, 106, 130, 142, 148], "627": [20, 92, 122, 136, 150], "y2": [20, 60, 106, 142, 148], "y3": [20, 60, 106], "rhf": [20, 21, 24, 33, 120, 121, 143, 144], "kcal": [20, 44, 58, 59, 65, 122, 136, 150], "mol": [20, 33, 44, 47, 52, 58, 59, 61, 62, 65, 67, 122, 130, 131, 136, 143, 144, 145, 148, 150, 153, 156, 157], "dz": [20, 75], "closer": [20, 33, 43, 52, 55, 75, 78, 101, 143, 144], "On": [20, 21, 52, 67, 68, 72], "goe": [20, 74], "significantli": [20, 21, 27, 69, 80, 89, 90, 92, 101, 143, 144, 149], "partli": [20, 60], "bs_drv": 20, "guess_unpaired_electron": 20, "e_b": [20, 99], "bs_result": 20, "y4": 20, "set_ylabel": [20, 58, 59, 60, 100], "axin": 20, "inset_ax": 20, "indicate_inset_zoom": 20, "energt": 20, "bifurc": 20, "poorli": [20, 21, 90], "contamin": [20, 122, 144, 148], "realli": [20, 43], "transit": [20, 21, 33, 43, 45, 46, 47, 48, 56, 60, 61, 67, 69, 70, 72, 73, 75, 78, 80, 82, 86, 90, 99, 101, 102, 103, 104, 105, 113, 117, 120, 123, 124, 125, 128, 129, 132, 141, 142, 143, 144, 145, 147, 148, 149, 150, 151, 158], "regim": [20, 61, 91, 141, 144], "bs_tensor": 20, "rho1_a": 20, "get_dens": [20, 28], "rho1_b": 20, "rho2_a": 20, "rho2_b": 20, "sharei": 20, "suptitl": 20, "profil": [20, 65, 70, 120], "pass": [20, 76], "suddenli": 20, "mostli": [20, 66, 74, 101, 124], "becaus": [20, 21, 41, 45, 47, 52, 60, 70, 71, 72, 73, 90, 91, 101, 149], "fundament": [20, 43, 45, 66, 67, 91, 130, 150], "fragment": [20, 21, 72, 81, 120, 153], "modern": [20, 43, 67], "absenc": [20, 91, 100, 122], "relativist": [20, 67, 89, 141, 144], "unphys": [20, 41, 143, 144], "promis": 20, "rho_2": 20, "r_1": 20, "r_2": 20, "henc": [20, 33, 46, 49, 66, 72, 90], "behav": [20, 22, 46, 67, 82, 91, 105], "get_ontop": 20, "twodm": 20, "active_orbit": 20, "den_i": 20, "aodensitymatrix": [20, 70], "_get_inactive_dens": 20, "denmat": [20, 70], "rest": [20, 21, 33, 70, 82, 100, 133, 142, 150], "rho_i": [20, 153], "ontop": 20, "mcscf_drv": [20, 21, 90, 92, 101, 124, 144], "mcscfdriver": [20, 21, 24, 90, 101, 120, 122, 124, 144], "den": 20, "get_total_dens": 20, "rho1": [20, 143], "ontop1": 20, "ci_driv": 20, "rho2": [20, 143], "ontop2": 20, "rho": [20, 31, 61, 105, 108, 143], "simultan": [20, 21, 30, 74, 113, 122, 124, 143, 144], "likelihood": [20, 47], "push": [20, 39, 98, 143], "toward": [20, 39, 60, 67, 69, 75, 143, 149], "littl": [20, 143], "unlik": [20, 21, 101], "rho_": [20, 153], "uncorrel": [20, 89], "quadrat": [20, 60, 64, 74, 83, 89, 117], "pm": [20, 21, 31, 46, 88], "arbitrarili": [20, 82], "radic": 20, "rho_a": 20, "rho_b": 20, "weird": [20, 21], "chose": [20, 143], "imagin": [20, 72, 73], "predict": [20, 67, 91, 92, 102], "reminesc": 20, "retain": [20, 38], "briefli": [20, 49], "bound": [20, 47, 144], "local": [20, 26, 34, 43, 46, 47, 50, 52, 55, 57, 60, 67, 69, 71, 72, 80, 89, 98, 133, 141, 142, 144, 153], "particularli": [20, 70, 122, 133, 143, 149], "blindli": 20, "tri": 20, "motiv": [20, 21, 33, 47, 69, 101], "gain": [20, 43, 90, 144], "anyth": 20, "analogu": 20, "dr": 20, "compute_pdft": 20, "tblyp": 20, "mcscf_result": [20, 21, 90, 101, 122, 124, 144], "e_h_tblyp": 20, "e_tblyp": 20, "y5": 20, "gentler": 20, "Of": [20, 21, 47, 55, 72, 130], "multi": [20, 21, 24, 30, 45, 90, 101, 102, 117, 120, 124, 149, 150, 152, 153], "bfg": [20, 60, 90, 101, 120, 124], "496396614": 20, "496403222": 20, "496403255": 20, "49640325498824395": 20, "00000": [20, 33, 72, 75, 100, 101, 113, 120, 124, 144, 151], "No": [20, 24, 34, 36, 41, 70, 90, 101, 120, 122, 124, 125, 133, 143, 148], "11565": 20, "58": [20, 25, 67, 90, 101, 120, 122, 124, 143, 144, 148, 150, 156], "51": [20, 59, 67, 81, 90, 101, 120, 122, 124, 143, 156], "51785": 20, "31509": 20, "35": [20, 24, 52, 65, 67, 70, 90, 100, 101, 120, 122, 124, 125, 143, 156], "94": [20, 24, 67, 70, 89, 98, 101, 120, 124, 131, 143, 148, 156], "1p0": [20, 24, 70, 90, 101, 120, 122, 124, 125, 143, 148], "deby": [20, 33, 84, 90, 101, 120, 124], "superposit": [20, 70, 120, 122, 125, 143, 148], "cauchi": [20, 70, 72, 76, 98, 120, 125, 143, 148, 151], "schwarz": [20, 70, 72, 76, 89, 98, 120, 125, 143, 148], "mode": [20, 43, 50, 61, 65, 66, 70, 120, 125, 130, 131, 132, 141, 143, 144, 148, 155], "5291772109": [20, 120], "sec": [20, 70, 72, 76, 89, 98, 120, 125, 143, 148], "sad": [20, 70, 120, 125, 143, 148], "095959327021": [20, 120], "100056242572": [20, 120], "02692675": [20, 120], "00838888": [20, 120], "00000000": [20, 25, 26, 28, 38, 70, 72, 88, 89, 92, 94, 96, 102, 105, 113, 115, 120, 125, 143, 148, 157], "100153689745": [20, 120], "0000974472": [20, 120], "00051916": [20, 120], "00017723": [20, 120], "00493758": [20, 120], "100153764817": [20, 120], "0000000751": [20, 120], "00001420": [20, 120], "00000490": [20, 120], "00030702": [20, 120], "100153764873": [20, 120], "0000000001": [20, 120, 143], "00000815": [20, 120], "1001537649": [20, 120], "6293309758": [20, 120], "0000000003": [20, 120, 143], "52504": [20, 120], "38": [20, 24, 26, 65, 67, 70, 90, 101, 120, 122, 124, 125, 143, 148, 156], "14359": [20, 120], "53961": [20, 120], "78": [20, 44, 70, 72, 90, 120, 124, 130, 143, 148, 156], "79480": [20, 120], "47": [20, 24, 26, 67, 72, 89, 90, 101, 120, 122, 124, 125, 143, 156], "28713": [20, 120], "63": [20, 28, 72, 98, 101, 120, 122, 125, 143, 156], "143566377": 20, "148744377": 20, "148804711": 20, "149285428": 20, "149310085": 20, "5e": [20, 75, 90, 101, 120, 124, 150], "149314174": 20, "149314195": 20, "149314199": 20, "149314200": 20, "1493141999268626": 20, "98226": 20, "01774": 20, "982": 20, "33023": 20, "018": [20, 70, 125], "11039": 20, "39": [20, 70, 90, 101, 120, 122, 125, 131, 143, 156], "35559": 20, "77": [20, 67, 76, 89, 90, 100, 101, 120, 125, 131, 143, 156], "44574": 20, "01604": 20, "49": [20, 38, 59, 81, 89, 90, 100, 101, 122, 124, 125, 143, 154, 156], "000010": 20, "000025": 20, "000015": 20, "000039": [20, 81], "000235": 20, "000596": 20, "000598": 20, "052521357": 20, "077746302": 20, "082349570": 20, "082358066": 20, "082364708": 20, "082364599": 20, "082365046": 20, "082365361": 20, "082365882": 20, "082366076": 20, "082366110": 20, "082366111": 20, "082366111035586": 20, "99459": 20, "00541": 20, "995": [20, 26], "42354": 20, "43": [20, 24, 26, 44, 67, 70, 81, 90, 101, 120, 122, 124, 143, 156], "005": [20, 26], "56953": 20, "44": [20, 24, 44, 78, 81, 101, 120, 122, 125, 130, 143, 148, 156], "26170": 20, "72": [20, 89, 90, 102, 105, 120, 124, 143, 156], "71": [20, 24, 72, 89, 101, 120, 143, 148, 156], "49397": 20, "03346": 20, "54": [20, 70, 90, 100, 101, 120, 122, 124, 143, 148, 156], "03348": 20, "000004": [20, 81, 101, 120], "000173": 20, "000441": 20, "000174": 20, "140699969": 20, "142676262": 20, "142880436": 20, "142880613": 20, "142880728": 20, "142880744": 20, "142880752": 20, "1428807519481459": 20, "99327": 20, "00673": 20, "993": [20, 70], "39893": 20, "45658": 20, "28012": 20, "47279": 20, "01948": 20, "53": [20, 24, 62, 67, 91, 98, 100, 101, 122, 125, 143, 148, 156], "000001": [20, 120], "000002": [20, 81, 101, 120], "000006": 20, "000262": 20, "000666": 20, "325": [20, 150], "157198837": 20, "157569007": 20, "157610561": 20, "157610575": 20, "157610614": 20, "157610618": 20, "157610623": 20, "1576106228624794": 20, "99246": 20, "00754": 20, "992": [20, 101], "38799": 20, "008": 20, "40306": 20, "28957": 20, "46548": 20, "79": [20, 70, 100, 120, 131, 143, 156], "80": [20, 24, 62, 67, 92, 101, 120, 143, 156], "01397": 20, "000296": 20, "000753": 20, "165420916": 20, "165729971": 20, "165764279": 20, "165764286": 20, "165764335": 20, "1657643354660694": 20, "99152": 20, "00848": 20, "37784": 20, "35251": 20, "29914": 20, "45962": 20, "00965": 20, "00966": 20, "000003": 20, "000007": 20, "000221": 20, "000563": 20, "375": 20, "168853647": 20, "169112740": 20, "169140865": 20, "169140864": 20, "169140933": 20, "1691409331842553": 20, "99043": 20, "00957": 20, "990": 20, "36845": 20, "010": 20, "30407": 20, "30871": 20, "45561": 20, "56": [20, 67, 81, 100, 101, 124, 143, 156], "00668": 20, "00670": 20, "000005": [20, 81], "000013": [20, 81], "000273": 20, "000693": 20, "168787524": 20, "169005343": 20, "169028405": 20, "169028485": 20, "169028485352778": 20, "98919": 20, "01081": 20, "989": 20, "35972": 20, "011": [20, 67, 125], "25869": 20, "92": [20, 67, 101, 120, 143, 156], "31822": 20, "45263": 20, "61": [20, 67, 70, 120, 143, 156], "00523": 20, "000259": 20, "000659": 20, "161128629": 20, "161808476": 20, "161869221": 20, "161869236": 20, "161869579": 20, "161869641": 20, "161869653": 20, "1618696533991333": 20, "98614": 20, "01386": [20, 75], "986": [20, 144], "34398": 20, "014": [20, 67, 125], "17736": 20, "33713": 20, "44911": 20, "00720": 20, "32": [20, 24, 28, 61, 62, 70, 76, 97, 101, 113, 120, 122, 124, 125, 131, 143, 148, 156], "00721": 20, "000018": [20, 81], "000012": 20, "000030": 20, "000237": 20, "000604": 20, "000238": 20, "000605": 20, "148779644": 20, "149275807": 20, "149313834": 20, "149313851": 20, "149314144": 20, "149314192": 20, "1493142001660392": 20, "98225": 20, "01775": 20, "11032": 20, "44580": 20, "01603": 20, "000236": 20, "000600": 20, "117019706": 20, "118299607": 20, "118361209": 20, "118362130": 20, "118362287": 20, "118362304": 20, "1183623041338808": 20, "97103": 20, "02897": 20, "971": 20, "30735": 20, "029": 20, "01021": 20, "39129": 20, "44069": 20, "05216": 20, "57": [20, 67, 76, 81, 90, 100, 101, 120, 122, 143, 156], "05217": 20, "000009": [20, 81], "000008": 20, "000020": [20, 120], "000203": 20, "000517": 20, "000204": 20, "086880553": 20, "087620796": 20, "087643410": 20, "087643431": 20, "087643830": 20, "087643871": 20, "087643878": 20, "0876438777327964": 20, "95315": 20, "04685": 20, "953": [20, 144], "28914": 20, "047": 20, "05684": 20, "59": [20, 24, 101, 120, 122, 124, 131, 143, 148, 156], "42504": 20, "43766": 20, "04502": 20, "10184": 20, "000014": 20, "000064": 20, "000028": 20, "000070": 20, "073560812": 20, "073683015": 20, "073686144": 20, "073686146": 20, "073686198": 20, "0736861977839984": 20, "94069": 20, "05931": 20, "941": 20, "28139": 20, "059": [20, 67], "08157": 20, "43712": 20, "81": [20, 44, 60, 62, 70, 76, 89, 120, 131, 143, 156], "43979": 20, "89": [20, 76, 98, 101, 143, 156], "00945": 20, "12654": 20, "64": [20, 62, 65, 76, 89, 90, 100, 101, 120, 124, 125, 143, 144, 148, 156], "000011": 20, "000027": 20, "060834921": 20, "060927904": 20, "060929937": 20, "060929939": 20, "060929976": 20, "0609299759850992": 20, "92513": 20, "07487": 20, "925": [20, 150], "27431": 20, "075": 20, "10202": 20, "43772": 20, "45146": 20, "99641": 20, "14891": 20, "049377798": 20, "049448418": 20, "049449776": 20, "049449777": 20, "049449803": 20, "0494498033566835": 20, "90585": 20, "09415": 20, "906": 20, "26777": 20, "094": 20, "11880": 20, "43938": 20, "45872": 20, "00427": [20, 75], "16807": 20, "022299527": 20, "022652787": 20, "022659725": 20, "022659729": 20, "022659836": 20, "0226598364942836": 20, "81873": 20, "18127": 20, "819": [20, 83, 113, 156], "25002": 20, "181": 20, "15227": 20, "45080": 20, "45534": 20, "10024": 20, "20552": 20, "000023": [20, 81], "000026": 20, "999662902": 20, "999866062": 20, "999867885": 20, "999867891": 20, "999867909": 20, "9998679085818645": 20, "55489": 20, "44511": 20, "555": 20, "22008": 20, "445": 20, "16990": 20, "42907": 20, "48629": 20, "22325": 20, "23230": 20, "000016": 20, "000040": 20, "993557101": 20, "993586946": 20, "993587298": 20, "993587300": 20, "993587315": 20, "9935873149617622": 20, "27419": 20, "72581": 20, "274": [20, 100], "19023": 20, "726": 20, "16441": 20, "42499": 20, "51450": 20, "25237": 20, "992627083": 20, "992651090": 20, "992652443": 20, "992652516": 20, "992652518": 20, "992652519": 20, "9926525186787301": 20, "05363": 20, "94637": 20, "054": [20, 70, 150], "15719": 20, "946": 20, "15112": 20, "45665": 20, "50852": 20, "27565": 20, "27566": 20, "denomin": [21, 22, 33, 82, 117, 143], "scame": 21, "few": [21, 35, 42, 46, 47, 52, 53, 69, 72, 73, 91, 102, 106, 125, 128, 143, 144, 149], "cheaper": 21, "dramat": [21, 90], "qualit": [21, 121], "homolyt": [21, 120], "oh": [21, 33, 52, 130, 133], "8957": 21, "3167": 21, "e_oh_hf": 21, "e_oh_fci": 21, "ohdist": [21, 33, 52], "200": [21, 58, 75, 90, 100, 131, 132, 133, 137, 139], "get_natural_occup": [21, 24, 120], "explan": [21, 23], "increasingli": [21, 82, 148], "highest": [21, 31, 64, 72, 96, 126, 143, 144], "sigma_star": 21, "noni": 21, "9999994": 21, "99931502": 21, "9986904": 21, "97454512": 21, "00019271": 21, "99980729": 21, "02745005": 21, "casci": [21, 90], "major": [21, 76], "flaw": 21, "behind": [21, 43, 52, 64, 144], "tempt": 21, "relax": [21, 43, 46, 57, 58, 59, 64, 69, 90, 96, 123, 128, 141, 142, 144, 148, 149], "enough": [21, 51, 60, 71, 89], "e_casscf": 21, "zz": [21, 38, 61, 76, 82, 83, 84, 89, 131, 144], "did": [21, 46, 60, 144], "zone": 21, "again": [21, 33, 46, 47, 61, 72, 82, 142, 143], "difficulti": [21, 46, 47, 49, 90, 98, 120, 143, 149], "essenti": [21, 59, 69, 71, 75, 82, 106], "homo": [21, 72, 86, 90, 96, 102, 105, 113, 124, 125, 126, 137, 142, 153, 157], "lumo": [21, 72, 86, 102, 105, 113, 124, 125, 126, 142, 144, 148, 153, 157], "lone": [21, 90, 92, 101, 124], "request": [21, 72, 76, 89, 94, 98, 124, 133], "geometri": [21, 33, 43, 45, 46, 47, 53, 59, 60, 62, 64, 65, 66, 67, 100, 130, 132, 133, 137, 155], "easier": [21, 84, 142], "hope": [21, 101, 150], "stabl": [21, 43, 44, 83, 92, 122, 143, 144], "similarli": [21, 43, 45, 80, 84, 86, 89, 117, 124], "stronger": [21, 143], "reorder": [21, 38, 106, 113, 148], "recommend": [21, 42, 123, 141, 143, 145, 148, 157], "borrow": 21, "kappa": [21, 33, 38, 49, 61, 70, 86, 88, 90, 96, 97, 111], "kappa_": [21, 38, 86, 88, 90, 97, 111], "qp": [21, 24, 33, 38, 46, 72], "neglect": [21, 33, 46, 55, 72, 80, 90, 101, 106, 144], "hessian": [21, 43, 45, 46, 52, 57, 60, 61, 64, 65, 88, 106, 111, 115, 129, 130, 132, 148, 156], "sum_r": 21, "pr": [21, 24], "rq": 21, "rst": 21, "gamma_": [21, 33, 46, 70, 72, 75, 76, 83, 91, 130], "prst": 21, "st": [21, 46, 60, 67], "2h_": 21, "ss": [21, 22, 71, 72], "iq": [21, 46], "jj": [21, 25, 41], "qj": [21, 46, 49], "tq": 21, "sum_u": 21, "uq": [21, 46], "uj": 21, "uvw": 21, "vw": 21, "pj": [21, 49], "analog": [21, 25, 46, 49, 61, 72, 96, 111], "newton": [21, 55, 64], "rate": [21, 27, 55, 65, 117, 123], "displac": [21, 25, 45, 46, 50, 60, 65, 100, 130, 131, 132, 150, 156], "algorithm": [21, 32, 33, 46, 52, 55, 56, 60, 67, 70, 72, 100, 113, 153], "ia": [21, 22, 33, 38, 46, 49, 70, 72, 80, 86, 88, 94, 97, 106, 113], "aa": [21, 38, 67, 125, 143, 153], "ta": 21, "tt": 21, "moder": [21, 43, 71, 89, 90], "water_stretch": 21, "reus": [21, 33], "wrote": 21, "ci_integr": 21, "molspac": 21, "silent": 21, "outputstream": [21, 125, 145], "deactiv": [21, 122], "feed": [21, 47], "_update_integr": [21, 22], "dact": 21, "d2act": 21, "dact_pq": 21, "jact": 21, "kact": 21, "feff": 21, "qn": 21, "tn": 21, "fiq": 21, "pu": [21, 46, 67], "ftq": 21, "quvw": 21, "fpq": 21, "fqp": 21, "transpos": [21, 33], "diag1": 21, "qm": [21, 35, 39, 40, 51, 52, 55], "diag2": 21, "hess": [21, 149], "divis": [21, 105], "expx": 21, "expm": [21, 97, 99], "newmo": 21, "en": [21, 52, 81, 92], "newmolorb": 21, "molorb": 21, "88252747": 21, "25e": 21, "89753572": 21, "89903251": 21, "89930538": 21, "40e": [21, 72], "89938498": 21, "89941463": 21, "75e": [21, 72], "89942666": 21, "89943169": 21, "03e": 21, "89943383": 21, "89943474": 21, "33e": [21, 89], "89943514": 21, "84e": 21, "89943531": 21, "86e": 21, "89943538": 21, "89943542": 21, "58e": 21, "89943543": 21, "89943544": 21, "55e": [21, 72, 76], "truncat": [21, 32, 55, 72, 73, 100, 101, 118], "cluster": [21, 43, 46, 67, 68, 71, 72, 117, 128, 147, 149], "variant": 21, "mr": 21, "mrcisd": 21, "1141": 21, "55": [21, 67, 90, 99, 100, 101, 120, 124, 125, 143, 156], "31345": 21, "intern": [21, 31, 43, 56, 60, 67, 99, 111, 113, 123, 147], "harder": 21, "itua": 21, "ivwa": 21, "_u": 21, "_t": [21, 65], "_w": 21, "wors": [21, 33, 75, 101, 144], "trick": [21, 29, 122], "uncontract": 21, "superior": 21, "medium": [21, 67, 74, 89], "summari": [21, 65, 131], "mrmp2": 21, "caspt2": 21, "nevpt2": 21, "ic": [21, 46, 72], "ccsd": [21, 67, 128, 143, 149], "mk": [21, 34, 36, 41], "mrccsd": 21, "mrci_result": 21, "brillouin": [21, 75], "mrci": 21, "mrcis_result": 21, "04497247698047602": 21, "rspt": 22, "mp": [22, 43, 46, 145, 149], "hjo14": [22, 46, 67, 72], "sb09": [22, 67], "so12": [22, 46, 67, 72], "zeroth": [22, 33, 46, 70, 72, 73, 84, 88], "phi_n": [22, 27, 28], "cal": [22, 65, 76, 97, 98, 150], "phi_0": [22, 27], "master": [22, 72, 76, 89, 98, 148], "virt": [22, 86, 88, 96, 97, 113], "amplitud": [22, 43, 46, 65, 70, 72, 73, 88, 96, 97, 99, 111, 113, 117, 125, 130, 131, 132, 142, 143, 145, 150, 151, 153, 156], "jb": [22, 46, 70, 72, 80, 86, 106, 113], "ib": [22, 33, 46, 70, 72, 86, 106, 113, 144], "ja": [22, 25, 33, 46, 70, 72, 86], "nvirt": [22, 38, 86, 88, 94, 96, 106, 113, 115, 142], "ingredi": [22, 46, 52, 60, 70], "e_mp2_ss": [22, 33], "e_mp2_o": [22, 33], "subset": [22, 33, 70], "e_o": 22, "e_v": 22, "enegi": 22, "e_ijab": [22, 33], "15163083": 22, "05138187": 22, "20301270": 22, "compute_convent": [22, 144], "yet": [22, 144], "topic": [22, 43, 66, 143], "mp2_dimer_result": 22, "4060254140": 22, "4060254051": 22, "regardless": [22, 28, 65], "th": [22, 46, 70, 80, 144], "mpn": 22, "differenti": [22, 46, 49, 55, 61, 82, 84, 100], "npot_drv": [22, 25], "v_nucpot_ao": 22, "ai": [22, 25, 36, 39, 49, 72, 86, 88, 90, 97, 111, 143], "bj": [22, 25, 49, 86, 106, 113], "g_ao": 22, "h0": [22, 60, 81, 99], "v_1": 22, "v_2": 22, "third": [22, 34, 36, 41, 46, 47, 61, 67, 72, 76, 82, 88, 98, 115, 117, 120], "stencil": [22, 83], "lambda_v": 22, "e_mp2": [22, 33, 144], "12747116": 22, "12747066": 22, "commonli": [23, 32, 46, 47, 55, 70, 98, 104, 120], "versu": [23, 146], "strong": [23, 33, 47, 69, 74, 92, 96, 101, 105, 120, 121, 124, 128, 141, 142, 143, 149], "equiv": [24, 25, 27, 28, 84, 88, 97, 150], "dagger_p": [24, 70], "psi_q": [24, 28, 29], "nonzero": [24, 29, 82, 96, 102], "alpha_p": 24, "phi_q": [24, 28, 29, 46, 73], "beta_p": 24, "phi_p": [24, 26, 28, 29, 46, 73, 96], "NO": [24, 67, 120], "pp": [24, 33], "sum_q": 24, "u_": [24, 49, 97], "rohf": [24, 121, 122], "unoccuppi": 24, "rohf_drv": 24, "scfrestrictedopendriv": [24, 122], "rohf_result": 24, "149": [24, 67, 122, 142], "60946112": [24, 122], "nine": [24, 122], "print_orbit": [24, 122], "09511": 24, "73155": 24, "46": [24, 62, 67, 90, 101, 120, 122, 124, 125, 143, 148, 156], "70486": 24, "2p0": [24, 90, 101, 120, 122, 124, 125, 143, 148], "20397": 24, "47356": 24, "08237": 24, "33": [24, 70, 75, 90, 91, 98, 100, 101, 120, 122, 125, 143, 156], "10988": 24, "sigma_u": 24, "pi_g": 24, "p_": [24, 49, 82, 91], "pi_u": 24, "sigma_g": [24, 122], "casscf_drv": 24, "orbital_spac": 24, "casscf_result": 24, "70836718": 24, "predominantli": [24, 82], "civec": [24, 75, 122], "972": 24, "945": 24, "155": [24, 125], "024": [24, 26, 90, 101, 124], "iii": [24, 39, 67], "iv": 24, "96299851": 24, "96098176": 24, "03637598": 24, "04026925": 24, "beta_q": 24, "sum_p": [24, 96], "uhf_drv": 24, "uhf_result": 24, "udft": [24, 122], "62899231": 24, "n_alpha_electron": 24, "n_beta_electron": 24, "s_ab": 24, "occ_numb": 24, "orb": [24, 90, 124], "999": [24, 83, 90, 101, 122], "997": [24, 150], "994": [24, 26, 101], "natural_orbit": [24, 122], "natural_orb": [24, 122], "34641": 24, "09919": 24, "70203": 24, "20095": 24, "21925": 24, "65627": 24, "1d": [24, 26, 88, 100, 120, 122, 143], "001": [24, 26, 41, 46, 47, 70, 83, 99, 100, 101, 106, 113, 122, 148], "07548": 24, "1d0": [24, 120, 143], "freedom": [25, 26, 45, 52, 66, 129], "furthermor": [25, 40, 45, 47, 49, 62, 72, 82, 84, 143, 144, 148, 149], "psi_p": [25, 28, 29, 97], "elementari": [25, 82, 150], "pertin": 25, "12pt": [25, 28], "aj": [25, 36, 41, 46, 106, 113], "ba": [25, 33, 38, 46, 81, 86, 99, 122], "psi_c": [25, 146, 150], "psi_d": [25, 150], "phi_a": [25, 94, 96, 150], "phi_b": [25, 86, 150], "phi_c": [25, 144, 150], "phi_d": [25, 150], "quatum": 25, "govern": 25, "m_a": [25, 100], "2_a": 25, "magnitud": [25, 33, 41, 74, 82, 96, 99, 111, 129, 144], "mass": [25, 55, 78, 89, 91, 100, 150, 156], "1800": [25, 156], "1836": [25, 156], "veloc": [25, 74, 75, 78, 81, 89, 90, 91, 101, 124, 148, 150], "decoupl": [25, 46, 69, 82], "eigenst": [25, 27, 31, 100, 104, 106, 124, 130, 141, 142, 143, 144, 145, 151, 153], "2_i": 25, "z_a": [25, 36, 38, 39, 83], "z_b": 25, "brief": 25, "rep": 25, "v_k": 25, "parametr": [25, 46, 47, 67, 90], "rovibron": [25, 103], "phi_k": 25, "phi_": [25, 29, 31, 36, 40, 46, 72, 96, 100], "rangle_k": 25, "71500000": [25, 26], "e_nuc": 25, "e_tot": [25, 143, 145], "e_elec": 25, "762591694646": 25, "130": [25, 62, 156], "366128020400": 25, "112": [25, 26, 67, 156], "603536325754": 25, "occpui": 25, "v_ao": 25, "h_aver": 25, "188": [25, 100, 150], "97928532728588": 25, "oooo": 25, "g_oooo": 25, "chem_oooo": 25, "g_aver": 25, "iijj": 25, "ijji": [25, 29], "61315730688548": 25, "resid": 26, "hilbert": 26, "mathcal": [26, 27, 30, 31, 33, 38, 46, 49, 55, 91, 117], "spinor": [26, 31], "center": [26, 38, 46, 58, 66, 67, 82, 84, 143], "compactli": 26, "momentum": [26, 31, 76, 78, 89, 91, 98, 100, 128, 150], "2py": [26, 38], "2pz": [26, 38], "2px": [26, 38], "091": [26, 120], "228": 26, "109": [26, 100, 150, 156], "105": [26, 67, 90, 142, 143, 156], "004": [26, 70], "836": 26, "536": [26, 67, 144, 145], "231": 26, "114": [26, 67, 125, 156], "089": 26, "023": [26, 70, 90, 101, 124, 125], "856": 26, "526": [26, 67], "196": 26, "547": [26, 70], "028": [26, 70, 101], "056": 26, "845": 26, "541": [26, 90, 144], "621": 26, "942": [26, 156], "002": 26, "578": [26, 113], "852": 26, "248": 26, "017": [26, 120], "031": 26, "022": [26, 70, 125], "255": 26, "251": 26, "337": 26, "132": [26, 27, 38, 67, 76, 113, 120, 156], "285": [26, 67, 142], "get_avail_basi": 26, "suppli": [26, 94, 134], "directori": [26, 42], "3df": 26, "3pd": 26, "2df": 26, "2pd": 26, "ano": [26, 38], "mb": 26, "vdzp": 26, "vqzp": 26, "vtzp": 26, "pcv5z": 26, "pcvdz": [26, 143, 149], "pcvqz": [26, 143], "pcvtz": [26, 143, 144, 149], "pv5z": 26, "pv6z": 26, "pvqz": [26, 143], "pcseg": 26, "pcx": 26, "daug": [26, 78], "qzvp": 26, "qzvpd": 26, "qzvpp": 26, "qzvppd": 26, "sv": [26, 120], "svp": [26, 81, 88, 96], "tzvp": 26, "tzvpd": 26, "tzvpp": 26, "tzvppd": 26, "sadlej": [26, 98], "6g": 26, "taug": 26, "tabl": [26, 91, 102, 113, 124, 143, 144, 149], "2s1p": 26, "3s2p": 26, "tripl": [26, 75, 128, 133], "4s3p": 26, "momenta": 26, "3s2p1d": 26, "diffus": [26, 43, 78, 89, 98, 128, 143, 145, 148, 149], "expon": [26, 52, 146], "4s3p2d": 26, "get_dimensions_of_primitive_basi": 26, "nprim": 26, "get_label": [26, 34, 36, 39, 41, 83, 130, 131, 132, 156], "divid": [27, 33, 46, 70, 80, 82, 129], "pertub": 27, "undetermin": [27, 46], "unperturb": [27, 46, 49], "customiz": 27, "setup_system": 27, "energy_separ": 27, "verbos": [27, 70, 72], "h_0_diag": 27, "seed": [27, 97], "20220526": 27, "eigval": [27, 81], "e_exact": 27, "m_diag": 27, "4931": 27, "1577": [27, 156], "9948": 27, "2499": 27, "0431": [27, 153, 156], "4836": 27, "1796": 27, "2426": 27, "9848": 27, "1341": [27, 156], "2125": [27, 156], "4843": 27, "2393": 27, "0742": [27, 156], "9982": 27, "1831": 27, "0795": [27, 156], "492": [27, 144], "2116": 27, "2425": 27, "9965": 27, "1532": [27, 156], "0945": [27, 156], "4865": 27, "2328": [27, 156], "9925": 27, "rspt_solver": 27, "50000000": 27, "03590812": 27, "49306122": 27, "02896934": 27, "46820039": 27, "00410850": 27, "46796433": 27, "00387245": 27, "46420937": 27, "00011749": 27, "46437373": 27, "00028185": 27, "46401910": 27, "00007279": 27, "46407353": 27, "00001836": 27, "46407816": 27, "00001372": 27, "46408390": 27, "00000798": 27, "critic": [27, 67, 78, 82], "noninteract": 27, "straightforwardli": [27, 38, 82, 102], "parenthesi": [27, 72], "sum_n": [28, 90], "formula": [28, 46, 49, 67, 75, 99, 101], "70000000": 28, "infinitesim": [28, 30], "consequ": [28, 29, 38, 40, 41, 74, 97, 102, 132], "d_mo": 28, "d_ao": 28, "half": [28, 73, 130, 143], "intersect": [28, 123, 124, 143], "bohr": [28, 100, 150, 157], "2000": [28, 156], "one_part_den": 28, "lw": [28, 47, 99], "ko": [28, 113], "panel": [28, 72, 124, 144], "enlarg": 28, "cusp": [28, 47], "_3": [28, 38, 91, 123, 132, 133, 142, 143, 144], "psi_r": [28, 29, 97], "get_two_particle_dens": 28, "two_part_den_aa": 28, "two_part_den_ab": 28, "figtext": 28, "hole": [28, 67, 69, 71, 72, 73, 94, 105, 141, 144, 145, 147, 148, 153], "k_1": [29, 150], "k_p": [29, 150], "k_m": [29, 150], "prod_": [29, 97], "m_p": 29, "sub": [29, 38, 113, 129], "oplu": 29, "vacuum": [29, 39, 89, 150], "vac": [29, 97], "0_1": 29, "0_2": 29, "0_m": 29, "destroi": 29, "k_2": 29, "1_p": 29, "0_p": 29, "popul": [29, 92, 122, 143, 145], "destruct": [29, 144], "dagger_": [29, 38, 97], "i_1": [29, 82], "i_2": [29, 82], "i_n": [29, 82], "leftrightarrow": [29, 30, 46], "i_p": 29, "lost": 29, "presum": 29, "occupationnumbervector": 29, "occ_orb": 29, "occ_num_vec": 29, "dtype": [29, 86, 88, 97, 99], "__mul__": 29, "array_equ": 29, "inner_prod": 29, "els": [29, 52, 60, 86, 136, 143], "__str__": 29, "noccup": 29, "prod": 29, "seri": [29, 33, 55, 68, 70, 72, 73, 76, 89, 100, 108, 128, 143], "dagger_i": [29, 86, 90], "ket": [29, 46, 70, 72, 73], "bra": [29, 46, 70, 72, 73], "denisti": 29, "_r": [29, 70, 73, 97], "g_": [29, 38, 46, 49, 65, 91], "phi_r": [29, 46, 97], "sigma_p": 29, "sigma_q": 29, "sigma_r": 29, "kroneck": [29, 46, 72], "ri": [29, 38], "pqii": 29, "iqri": 29, "jjii": 29, "obei": [30, 91], "permut": [30, 72, 82, 98, 143], "span": [30, 49, 144], "distinct": [30, 47, 49, 72, 99, 111, 120], "inhomogen": [31, 67, 151], "speak": [31, 43, 103], "pauli": 31, "_x": [31, 45, 52, 82, 88, 102], "_y": [31, 82, 102], "cyclic": [31, 33], "civita": 31, "2p_": 31, "fine": [31, 46, 100, 123, 129, 144, 150], "m_j": [31, 55, 66], "r_": [31, 36, 38, 39, 41, 47, 49, 84, 90, 91, 100, 150], "spheric": [31, 74, 84], "harmon": [31, 50, 52, 55, 65, 76, 82, 91, 98, 100, 132, 156], "regular": 31, "y_1": 31, "meshgrid": [31, 60], "arctan": 31, "exp": [31, 38, 60, 65, 70, 130, 131, 132, 151, 156], "fig1": 31, "h1": [31, 52], "frame_on": 31, "quiver": 31, "pivot": 31, "mid": [31, 84, 91, 117, 150], "ytick": [31, 113], "q2": 31, "doublet": 31, "unabl": 31, "s_1": 31, "t_1": [31, 38], "remind": 33, "den1": 33, "dm": [33, 46, 153], "nstate": [33, 72, 75, 81, 94, 101, 102, 105, 106, 113, 115, 122, 124, 144, 148, 151, 153], "hint": 33, "idx": [33, 88, 106, 113, 148], "argsort": [33, 106, 113, 148], "yourself": [33, 43], "warn": [33, 92, 148, 153], "omp_num_thread": [33, 92, 148, 153], "895700000000": [33, 52], "316700000000": [33, 52], "100000000000": [33, 52], "n_mo": [33, 144], "n_o": [33, 70], "n_v": [33, 70], "epsilon_a": [33, 46, 70, 72, 106, 113], "epsilon_i": [33, 46, 70, 72, 106, 113], "epsilon_ov": 33, "c_occ": 33, "c_vir": 33, "moeridrv": [33, 70], "eri_oovv": 33, "moints_nam": [33, 70], "chem_oovv": [33, 70, 86], "eri_ooov": 33, "chem_ooov": 33, "eri_ovvv": 33, "chem_ovvv": 33, "valid": [33, 46, 47, 67, 89, 91, 133, 149], "varepsilon_b": [33, 72], "varepsilon_j": [33, 72], "varepsilon_p": [33, 72], "get_mp2_correct": 33, "sc_fdrv": 33, "oovv": [33, 70, 86], "e_ij": 33, "e_ab": [33, 70], "algebra": [33, 43, 67, 73, 97, 118, 128, 149], "e_occ": [33, 70], "e_vir": [33, 70], "epsilon_b": [33, 46, 70, 72], "e_mp2_vlx": 33, "ncomparison": 33, "nativ": 33, "292550395109": 33, "208104435264": 33, "surviv": [33, 80, 91], "get_t_amplitud": [33, 70], "t_aaaa": [33, 70], "t_abab": [33, 70], "t_abba": [33, 70], "t_bbbb": [33, 70], "t_baba": [33, 70], "t_baab": [33, 70], "t2_aaaa": [33, 70], "t2_abab": [33, 70], "t2_abba": [33, 70], "t2_mp2": [33, 70], "aaaa": [33, 70], "abab": [33, 70], "abba": [33, 70], "frac14": [33, 70, 72], "care": [33, 46, 55, 60, 98, 100, 124, 128, 142, 143, 144, 148, 149], "t2": [33, 70], "ijba": 33, "overestim": [33, 41, 128, 143, 144], "templat": 33, "scf_drv_pec": 33, "disabl": 33, "printout": 33, "character": [33, 46, 60, 64, 65, 69, 74, 82, 84, 89, 91, 98, 130], "energet": [33, 65, 143], "analyt": [33, 43, 48, 50, 55, 60, 61, 66, 67, 83, 84, 89, 91, 96, 130], "mu_": [33, 38, 39, 46, 49, 61, 70, 75, 82, 83, 84, 91, 99, 100], "latin": 33, "greek": [33, 46], "firstorderproperti": [33, 131], "scf_densiti": 33, "prop": 33, "firstorderprop": [33, 131], "hf_dipole_mo": 33, "get_properti": [33, 131, 142], "print_properti": 33, "646957": 33, "644400": 33, "788215": 33, "170427": 33, "831723": 33, "281016": 33, "frac12": [33, 46, 49, 61, 72], "kab": 33, "ikab": [33, 46], "jkab": [33, 46, 72], "ijc": 33, "ijac": [33, 46], "ijbc": [33, 46, 72], "gamma_ij": 33, "vir": [33, 70], "gamma_ab": 33, "gamma_ao": 33, "unrelaxed_dens": 33, "ur_mp2_dipole_mo": 33, "295983": 33, "752313": 33, "563049": 33, "139860": 33, "570917": 33, "159859": 33, "respons": [33, 40, 43, 46, 49, 61, 67, 74, 78, 83, 93, 96, 100, 103, 104, 108, 113, 117, 118, 124, 131, 142, 143, 144, 148], "lambda_": [33, 38, 46, 94, 113], "bigg": [33, 49, 61, 66], "jkb": [33, 72], "jbc": [33, 72], "bc": [33, 38, 46, 72, 144], "varepsilon_c": 33, "cb": [33, 136], "varepsilon_k": 33, "term1": 33, "jacb": 33, "term2": 33, "lambda_ov": 33, "lambda_ao": 33, "rel_mp2_dipole_mo": 33, "jkib": 33, "kjib": 33, "jabc": 33, "385919": 33, "980908": 33, "242851": 33, "867744": 33, "254768": 33, "898034": 33, "strength": [33, 41, 43, 46, 55, 70, 72, 74, 75, 76, 83, 89, 90, 96, 98, 100, 101, 106, 111, 113, 117, 124, 143, 144, 148, 151], "scf_drv_p": 33, "method_dict_p": 33, "electric_field": [33, 83, 96], "00001": [33, 81, 120], "hf_e_p": 33, "mp2_e_p": 33, "field_strength": [33, 83, 96], "hf_mu_z": 33, "mp2_mu_z": 33, "scf_drv_m": 33, "method_dict_m": 33, "hf_e_m": 33, "mp2_e_m": 33, "5f": [33, 70, 75, 81, 83, 113, 124, 137, 144, 150, 151], "78821": 33, "36478": 33, "56305": 33, "24285": 33, "09314": 33, "16276": 33, "09078": 33, "83863": 33, "isom": 33, "16263": 33, "72155": 33, "08733": 33, "825": [33, 120], "metal": [33, 120, 147, 149], "worst": [33, 149], "scenario": 33, "merz": [34, 36, 41, 67], "kollman": [34, 36, 41, 67], "dens": [34, 43, 144], "exclus": 34, "bw90": [34, 67], "electrostat": [34, 35, 36, 39, 40, 41, 67], "methanol": [34, 36, 41, 125, 133, 137, 139], "methanol_xyz": [34, 36, 41, 133, 137], "2001": [34, 36, 41, 67], "0363": [34, 36, 41, 156], "8431": [34, 36, 41], "7031": [34, 36, 41], "0083": [34, 36, 41, 156], "1305": [34, 36, 41], "9877": [34, 36, 41], "8943": [34, 36, 41], "7114": [34, 36, 41], "0155": [34, 36, 41, 156], "8918": [34, 36, 41], "6742": [34, 36, 41], "6582": [34, 36, 41], "0067": [34, 36, 41, 156], "1730": [34, 36, 41, 156], "1326": [34, 36, 41, 156], "0311": [34, 36, 41, 81, 156], "6482": [34, 36, 41, 59], "respchargesdriv": [34, 36, 41], "esp_drv": [34, 36], "grid_typ": 34, "equal_charg": [34, 36, 41], "chelpg_charg": 34, "esp": [34, 37, 41], "conform": [34, 36, 41, 45, 47, 60, 67, 133], "margin": [34, 100], "5890": [34, 156], "003200": 34, "225480": 34, "611345": 34, "376265": 34, "fit": [34, 36, 41, 43, 100, 142], "root": [34, 36, 41, 75, 94, 101, 124], "186800": 34, "1990": [34, 67, 156], "361": [34, 67], "373": [34, 67], "zip": [34, 36, 41, 60, 70, 81, 100, 102, 105, 130, 131, 132, 156], "methyl": [34, 36, 41], "mm": [35, 36, 39, 40, 47, 62], "multiscal": [35, 53], "nobel": [35, 53], "prize": [35, 53], "2013": [35, 53, 156], "thousand": [35, 53], "induct": [35, 74, 91], "subsequ": [35, 66, 71, 103, 141], "goal": [36, 43, 143], "textbf": [36, 144], "q_a": [36, 38, 39, 41, 52], "bmk90": [36, 67], "sk84": [36, 67], "solvent": [36, 39, 53], "surfac": [36, 45, 47, 50, 51, 56, 57, 60, 62, 64, 67, 92, 123], "sum_a": [36, 38, 52, 90, 144], "1m": 36, "m1": 36, "q_1": [36, 45], "q_m": 36, "b_1": 36, "b_m": 36, "b_i": 36, "esp_charg": 36, "resp": [36, 37, 47, 62, 67], "420": [36, 41], "023220": 36, "148458": 36, "594785": 36, "376669": 36, "180034": 36, "1984": [36, 67, 156], "129": [36, 67, 76, 156], "chelpg": 37, "loprop": 37, "localis": 38, "glkarlstrom04": [38, 67], "meaning": [38, 43, 132], "suit": [38, 68, 82, 144], "fluorid": 38, "1733": 38, "5597": 38, "natom": [38, 81], "loprop_drv": 38, "lopropdriv": 38, "loprop_out": 38, "localized_charg": 38, "nlocal": 38, "xx": [38, 61, 82, 84, 88, 89, 131, 142, 144], "yy": [38, 61, 82, 84, 89, 131, 142, 144], "localized_polariz": 38, "1191": [38, 156], "4371": 38, "917": 38, "226": [38, 83], "9525": 38, "_4": [38, 132, 136, 139, 143], "orthonormalis": 38, "orthonomalis": 38, "aim": [38, 43, 65, 128, 149], "2443": 38, "1716": [38, 156], "0341": [38, 156], "0601": [38, 156], "7635": [38, 59], "2275": 38, "3321": 38, "4306": 38, "6374": 38, "6583": 38, "2409": 38, "5971": 38, "1098": [38, 156], "4105": [38, 156], "4995": 38, "re": [38, 46, 67, 91, 131, 143], "florid": 38, "1py": 38, "1pz": 38, "1px": 38, "t_0": [38, 55, 82, 99, 108], "rearranged_indic": 38, "angmom": 38, "get_basis_function_indices_for_atom": 38, "concaten": 38, "col": 38, "s0": 38, "choleski": 38, "intact": 38, "s_0": 38, "triangular": 38, "norb_per_atom": 38, "indices_occ": 38, "indices_virt": 38, "get_ao_indic": 38, "rf": 38, "s1": [38, 72, 81, 148], "0501": [38, 156], "2372": [38, 156], "3975": 38, "4416": 38, "0647": [38, 156], "5504": 38, "0641": [38, 156], "s1_oo": 38, "t2_oo": 38, "lowdin_orthonorm": 38, "s1_vv": 38, "t2_vv": 38, "s2": [38, 72, 81, 106, 113, 148], "0209": [38, 156], "0121": [38, 125, 153, 156], "0573": [38, 156], "1143": [38, 156], "0765": [38, 156], "2767": [38, 156], "0414": [38, 156], "4636": 38, "0698": [38, 156], "0505": [38, 156], "5822": 38, "1497": [38, 81, 156], "occipi": 38, "orthonormalizaton": 38, "s2_ov": 38, "index_occ": 38, "index_virt": 38, "s3": [38, 72, 81, 148], "7698": 38, "2818": [38, 156], "1001": [38, 156], "6502": 38, "1055": [38, 156], "8952": 38, "orthonmalis": 38, "s3_vv": 38, "t4_vv": 38, "index_virt1": 38, "index_virt2": 38, "s4": [38, 72, 81], "ef": 38, "af": 38, "9997": [38, 59], "2541": 38, "0022": [38, 156], "0123": [38, 156], "0032": [38, 156], "0527": [38, 156], "0229": [38, 156], "1253": [38, 156], "0183": [38, 125, 156], "1215": [38, 156], "1295": [38, 156], "045": 38, "0033": [38, 59, 156], "0222": [38, 156], "0237": [38, 156], "expctat": 38, "decomposit": [38, 94, 125], "atomic_properti": 38, "omega_ab": 38, "omega_l": 38, "d_l": 38, "dc": [38, 76, 98], "idx_a": 38, "idx_b": 38, "elem_ids_to_numpi": 38, "mu_ab": 38, "nmu_ab": 38, "9033": 38, "0947": [38, 156], "1471": 38, "4855": 38, "midpoint": 38, "get_coordin": [38, 47, 52, 65, 130, 131, 132, 156], "gaug": [38, 78, 90, 124], "orgin": 38, "5144": 38, "1116": [38, 156], "rangle_": [38, 76, 78, 82, 88, 89, 91, 98, 99, 113], "strucur": 38, "si": [38, 75, 76, 84, 91, 98, 101, 111, 124, 150], "lrs_drv": [38, 86, 113], "linearresponsesolv": [38, 78, 83, 86, 88, 89, 96, 106, 113, 131, 148], "lrs_out": [38, 113], "response_funct": [38, 78, 83, 86, 88, 89, 113, 124, 131, 142, 144], "8695": 38, "unpack": 38, "vec2mat": 38, "orign": 38, "exress": 38, "solution_z_0": 38, "get_full_solution_vector": [38, 94, 113, 142], "d1": [38, 83], "alpha_ab": 38, "nalpha_ab": 38, "869484": 38, "6304": 38, "2307": 38, "7776": 38, "dq_a": 38, "5231": 38, "3664": 38, "4019": [38, 59], "auxiliari": 38, "q_": [38, 39, 45, 84], "although": [38, 76, 90, 98, 142, 143, 144, 147], "lambda_a": 38, "penatli": 38, "r_a": [38, 39, 52, 83], "r_b": 38, "bragg": 38, "radii": 38, "bohr2ang": 38, "529177249": [38, 143], "dr_ab": 38, "l_": [38, 66, 82, 141, 143], "net": [38, 69, 74], "onc": [38, 46, 49, 55, 61, 65, 82, 100, 144], "l_ab": 38, "2963": [38, 156], "dq_ab": 38, "alpha_bond_ab": 38, "6396": 38, "sum_b": [38, 144], "alpha_a": 38, "tetrahedr": 39, "donor": 39, "acceptor": 39, "6891400000": 39, "8324710000": 39, "7224340000": 39, "8726890000": 39, "solvent_xyz": 39, "0991810000": 39, "2167050000": 39, "2791250000": 39, "2673500000": 39, "2529740000": 39, "6013580000": 39, "9984050000": 39, "8080510000": 39, "5840690000": 39, "8223690000": 39, "2141140000": 39, "3767710000": 39, "5990410000": 39, "8408210000": 39, "6698860000": 39, "4683410000": 39, "4151750000": 39, "5365150000": 39, "7377440000": 39, "0168380000": 39, "4861090000": 39, "0753880000": 39, "2446490000": 39, "3654140000": 39, "6636970000": 39, "7516570000": 39, "0543720000": 39, "0758700000": 39, "2692330000": 39, "5139440000": 39, "5822670000": 39, "1887880000": 39, "5058600000": 39, "1632420000": 39, "7082890000": 39, "8568430000": 39, "donors_xyz": 39, "acceptors_xyz": 39, "300": [39, 47, 59, 65, 70, 90, 92, 124, 130, 132, 133, 136, 137, 142, 154, 156, 157, 159], "setviewstyl": [39, 47, 59, 70, 90, 124, 130, 131, 132, 133, 136, 137, 139, 154, 156, 159], "style": [39, 47, 59, 70, 90, 124, 130, 131, 132, 133, 136, 137, 139, 154, 156, 159], "outlin": [39, 47, 59, 68, 70, 90, 124, 130, 131, 132, 133, 136, 137, 139, 154, 156, 159], "black": [39, 43, 47, 60, 99, 105, 124, 159], "probe": [39, 52, 67, 69, 74, 98, 117, 123, 128, 141, 142, 143, 144, 148, 149], "element_charg": [39, 83], "dipmom": [39, 83], "mu_e": [39, 83], "mu_n": [39, 83], "molecule_atom_label": [39, 83], "get_atom_coordin": [39, 83], "solver": [39, 43, 70, 76, 83, 89, 90, 98, 100, 113, 124, 125, 131, 148], "scf_solver": 39, "f_mo": 39, "c_hf": 39, "mu_hf": 39, "878333": 39, "tip3p": 39, "834": [39, 156], "417": [39, 90], "tip3p_charg": 39, "mu_tip3p": 39, "112794": 39, "get_embedding_oper": 39, "mm_site": 39, "mm_charg": 39, "atom_idx": 39, "atom_label": 39, "pot_drv": 39, "v_e": [39, 143], "v_n_e": 39, "solvent_atom_label": 39, "v_n_": 39, "v_n_d": 39, "v_d": 39, "e_d": 39, "c_d": 39, "v_n_a": 39, "v_a": [39, 52], "c_a": 39, "pentam": 39, "bi": [39, 46], "v_s_aver": 39, "08545956": 39, "00987780": 39, "07558176": 39, "destabil": 39, "stabil": 39, "benefici": 39, "diff": 39, "98692530": 39, "05504275": 39, "96958319": 39, "01734211": 39, "01370114": 39, "65101990": 39, "66472104": 39, "67779574": 39, "02542388": 39, "73647946": 39, "28894441": 39, "69798088": 39, "put": [39, 43, 47, 97, 144], "mu_d": 39, "mu_a": 39, "147602": 39, "006242": 39, "031627": 39, "pot": [39, 52], "pot_fil": 39, "potfil": 39, "05504276": 39, "q_i": [40, 45, 47, 52, 91], "perm": 40, "el": 40, "nuc": 40, "ind": [40, 81], "t_i": [40, 55], "crucial": 40, "spectroscop": [40, 43, 67, 88, 99, 111], "restrain": [41, 47], "bcck93": [41, 67], "ccbk95": [41, 67], "merit": [41, 99], "buri": 41, "2_": [41, 97], "interior": [41, 144], "hyperbol": 41, "penalti": 41, "rstr": 41, "q_j": [41, 47], "resp_drv": 41, "resp_charg": 41, "stage": [41, 103, 120, 143], "restraint": [41, 67], "0005": [41, 81, 125, 156], "075643": 41, "117258": 41, "013902": 41, "013047": 41, "639004": 41, "419154": 41, "139861": 41, "033747": 41, "118610": 41, "ye": [41, 100, 131, 132, 153], "203249": 41, "phy": [41, 67, 70, 76, 89, 98, 148], "1993": [41, 67, 156], "10269": [41, 67], "10280": [41, 67], "ga": [41, 67, 76, 142, 147, 150], "imit": 41, "aqueou": 41, "protein": [41, 52, 53, 67, 133], "manag": 42, "maco": 42, "linux": 42, "repositori": 42, "certifi": 42, "miniconda": 42, "pip": 42, "zlib": 42, "libmamba": 42, "blog": 42, "newer": 42, "agent": 42, "config": 42, "termin": 42, "anaconda": 42, "powershel": 42, "support": 42, "prompt": 42, "yml": 42, "folder": [42, 70, 105, 153], "asterisk": 42, "interf": 42, "servic": 42, "permiss": 42, "permit": 42, "readi": [42, 43], "web": 42, "browser": 42, "tree": 42, "unix": 42, "adcc": [42, 43, 106, 142, 143, 144, 145, 148], "xtb": [42, 52, 54, 58, 59, 137, 156], "echem_window": 42, "wsl": 42, "crash": 42, "runtim": 42, "caus": [42, 47, 55, 82], "die": 42, "di": [42, 146], "rerun": 42, "undocu": 42, "clone": 42, "git": 42, "com": [42, 66, 67], "kthpanor": 42, "doc": [42, 43], "navig": 42, "_build": 42, "welcom": 43, "platform": 43, "driven": [43, 67], "target": [43, 100, 101, 106, 144, 145, 148], "audienc": 43, "undergradu": 43, "student": 43, "background": [43, 47], "websit": 43, "tutori": [43, 52, 54, 120, 141, 143, 144, 149], "thing": [43, 52, 55, 88, 119, 120], "consult": [43, 133], "stand": [43, 46], "alon": [43, 105], "rais": [43, 60, 141], "curios": 43, "organ": [43, 67, 97], "spectra": [43, 67, 68, 69, 70, 78, 102, 104, 106, 109, 115, 123, 126, 129, 131, 132, 141, 143, 145, 146, 148, 149, 151, 153, 156], "intend": [43, 47], "insight": [43, 141, 142, 148], "matter": [43, 49, 70, 82, 103, 128, 133, 144], "varieti": [43, 74, 109], "affect": [43, 47, 126, 131, 133, 143, 151], "daunt": 43, "veteran": 43, "deeper": 43, "riddl": 43, "inconsist": 43, "challeng": [43, 45, 67, 104], "vagu": 43, "believ": 43, "human": [43, 53], "abstract": 43, "lectur": 43, "never": 43, "rebuild": 43, "dismantl": 43, "box": [43, 55], "seem": [43, 46], "cog": 43, "gear": 43, "addition": [43, 46, 69, 154], "concret": [43, 102, 105, 115], "peopl": 43, "team": [43, 54], "engag": 43, "effort": [43, 46], "overreach": 43, "scienc": [43, 67], "contemporari": 43, "futur": 43, "meet": [43, 99, 103], "eurohpc": 43, "multitud": 43, "coverag": 43, "3d": [43, 60, 152], "500": [43, 69, 70, 99, 100, 101, 122, 133, 139, 143, 150], "transpar": 43, "exposur": 43, "depth": [43, 47, 69], "analys": [43, 102, 126, 141, 153], "embed": [43, 52, 106, 141, 144], "synchron": 43, "experiment": [43, 47, 74, 76, 82, 89, 91, 98, 117, 122, 142, 143, 144, 148, 151], "partner": 43, "simd": 43, "notion": 43, "suprem": 43, "grant": 43, "opportun": [43, 72], "ago": 43, "manner": [43, 47, 61, 72, 88, 113, 117, 122, 123, 142, 143, 148, 149], "freeli": [43, 73, 82], "friendli": 43, "rlv": [43, 67], "nonlinear": [43, 71, 74, 76, 82, 89, 91, 98, 99], "highli": [43, 47, 91, 100, 143, 144], "hardwar": [43, 53], "infrastructur": 43, "job": 43, "schedul": 43, "rrh": [43, 67, 71, 143, 144], "propag": [43, 67, 68, 70, 72, 74, 82, 109, 118, 139, 143, 144], "Its": [43, 74], "diagrammat": [43, 67, 70, 73, 118, 128, 149], "adc": [43, 46, 67, 68, 69, 71, 73, 118, 123, 125, 126, 128, 141, 142, 143, 146, 148, 149, 153], "fashion": 43, "oscil": [43, 47, 55, 70, 72, 74, 75, 90, 91, 99, 100, 101, 106, 113, 124, 143, 144, 148, 151], "absorpt": [43, 67, 69, 73, 74, 82, 91, 100, 102, 103, 104, 106, 113, 123, 129, 130, 134, 141, 142, 143, 145, 146], "referec": 43, "pyscf": [43, 143, 144, 145, 148], "psi4": 43, "uv": [43, 70, 100, 102, 124, 129, 134], "vi": [43, 70, 100, 102, 124, 129, 134, 153, 157], "rai": [43, 67, 69, 70, 104, 106, 125, 129, 134, 142, 143, 145, 146, 149], "emiss": [43, 67, 91, 100, 103, 141, 142, 143, 145, 146, 148, 149], "variuo": 43, "releas": 43, "qc": 43, "aggreg": [43, 91, 102, 105], "multirefer": [43, 67, 128], "special": [43, 46, 49, 60, 64, 91, 98, 99, 117, 122], "io": 43, "intro": 43, "ue": 43, "tric": [43, 60], "deloc": [43, 60, 69, 105, 141, 142, 143, 144, 153], "dlc": [43, 60], "possibli": [43, 55], "vibrat": [43, 48, 61, 65, 67, 103, 123, 124, 130, 132, 141, 143, 144, 151, 155], "enegin": 43, "tight": [43, 59], "semi": [43, 59], "noncoval": [43, 67], "toolkit": 43, "free": [43, 54, 67, 88], "toolbox": 43, "nto": [43, 94, 105, 126, 153, 158], "smile": [44, 58, 59, 134, 136, 139, 140], "read_smil": [44, 58, 59, 133, 139], "oc": [44, 58, 59, 133], "atom_indic": [44, 58], "xtbdriver": [44, 58, 59, 136, 139, 156], "opt_drv": [44, 47, 58, 59], "optimizationdriv": [44, 47, 58, 59, 65, 131, 136, 139], "conformer_energi": 44, "conformer_structur": 44, "tran": [44, 65], "hocc": 44, "occc": [44, 58], "ccco": 44, "set_dihedral_in_degre": 44, "opt_result": [44, 58, 59], "opt_energi": [44, 59, 156], "final_geometri": [44, 58, 59, 136, 139], "idx_lowest_conform": 44, "lowest_conform": 44, "hartree_in_kcalpermol": [44, 58, 59], "dimension": [45, 67, 71, 83, 106, 143], "pe": [45, 47, 57, 60, 64, 65, 91, 147], "interplai": [45, 67], "elucid": 45, "explain": [45, 50, 64, 65, 72, 73, 90, 120, 143], "photo": [45, 64], "reaction": [45, 56, 64, 65, 67, 92, 120, 133, 148], "pathwai": [45, 73], "favor": 45, "dihedr": [45, 47, 52, 53, 58, 139], "pose": 45, "q_2": 45, "n_q": 45, "n_x": 45, "3n": [45, 49, 55, 66, 130, 136], "x_1": [45, 66], "x_2": [45, 66], "x_": [45, 46, 66, 70, 73, 91, 100], "wilson": [45, 52, 66, 67], "neal09": [45, 60, 67], "x_j": [45, 52, 66], "linearli": [45, 61, 74, 82, 96], "pf92": [45, 67], "ws16": [45, 66, 67], "x_k": 45, "ijk": 45, "confirm": [46, 72, 76, 91, 115], "magnetizabilit": 46, "nmr": 46, "epr": 46, "jen06": [46, 67], "greater": [46, 75, 101, 124], "x_0": [46, 49], "divided_differ": 46, "proport": [46, 55, 89, 102, 132, 144], "true_deriv": 46, "lim_": 46, "quotient": [46, 150], "symmetric_difference_quoti": 46, "2x_0": 46, "five_point_method": 46, "12x_0": 46, "debug": 46, "exhibit": [46, 74, 82, 142, 143, 144], "implicit": [46, 91, 133], "chain": 46, "lwk05": [46, 67], "reh15": [46, 67], "energy_functional_gener": 46, "hellmann": [46, 84], "feynman": [46, 67, 70, 73, 84], "hj88": [46, 67], "lev05": [46, 67], "surpris": 46, "variation": 46, "conundrum": 46, "phrase": 46, "lagrangian_gener": 46, "f_c": 46, "hf_energy_fct": 46, "1212": [46, 156], "hf_lagrangian": 46, "epsilon_p": 46, "uniti": 46, "partial_l": 46, "ehf_dm": 46, "partial_l_fin": 46, "braket": [46, 70, 72], "superscript": [46, 76, 91], "xi": [46, 76, 81, 91, 106, 124, 125, 142, 143, 144, 148, 151], "hpq": 46, "fockmatel": 46, "hf_gamma_ij": 46, "jl": [46, 72], "orbitalrspcond": 46, "programm": 46, "rd19": [46, 67], "orbitalrspcond_program": 46, "derivfock": 46, "qt": 46, "ui": 46, "epsilon_o": 46, "rt": [46, 65, 143], "ru": 46, "derivoverlap": 46, "epsilon_": [46, 91], "l_dm": 46, "orbrsp1": 46, "orbrsp2": 46, "epsilon_u": 46, "ut": 46, "tpqr": 46, "qr": 46, "qpsr": 46, "srpq": 46, "renam": 46, "epsilon_t": 46, "upqr": 46, "tp": [46, 143], "orbrspeq": 46, "omega_hf": 46, "omega_hf_oo": 46, "jpqr": 46, "ip": [46, 143], "klm": 46, "km": [46, 61, 130, 131, 156], "lm": 46, "hf_grad_fin": 46, "generaliz": 46, "breakdown": [46, 125], "invari": [46, 61], "safe": [46, 47, 90], "energy_functional_mp": 46, "mp2_energy_fct": 46, "mp2_tamplitud": 46, "epsilon_j": [46, 70, 72], "mp2_lagrangian": 46, "f_t": 46, "t_condit": 46, "amplitude_rsp_gener": 46, "t_cond_explicit": 46, "epsilon_c": [46, 72, 144, 146], "epsilon_d": [46, 72], "epsilon_k": [46, 72], "epsilon_l": [46, 72], "ampl_rsp_multipli": 46, "l_dms_mp": 46, "final_l_dms_mp": 46, "mp2_2pdm_oovv": 46, "ra_explicit": 46, "sum_c": 46, "ijcb": 46, "kjab": 46, "downarrow": [46, 74], "gammaa_ij": 46, "gammaa_ab": 46, "gammaa_ijab": 46, "mp2_gamma_ij": 46, "mp2_gamma_ab": 46, "mp2_gamma_ijkl": 46, "mp2_gamma_ijab": 46, "lambda_mp2_ov": 46, "pa": [46, 70], "apqr": 46, "ipqr": 46, "abjk": 46, "omega_mp2_oo": 46, "ka": [46, 72], "omega_mp2_ov": 46, "jkac": 46, "omega_mp2_vv": 46, "fhgp92": [46, 67], "tamm": [46, 80, 90, 94, 104], "dancoff": [46, 80, 90, 94, 104], "dhg05": [46, 67], "dw15": [46, 67, 68, 72, 73], "cis_eigenvalue_eq": 46, "omega_n": [46, 72, 82, 91], "excitation_energy_adc1": 46, "adc1_identify_dm": 46, "adc1_gamma_oo": 46, "adc1_gamma_vv": 46, "adc1_gamma_ovov": 46, "iajb": 46, "plug": 46, "reader": [46, 66, 72], "straightforwad": 46, "lambda_adc1_ov": 46, "jakb": 46, "kb": [46, 72, 76, 89, 98, 148], "ibkc": 46, "kc": [46, 72], "omega_adc1_oo": 46, "kajb": 46, "omega_adc1_ov": 46, "kajc": 46, "jc": [46, 72], "omega_adc1_vv": 46, "rpa": [46, 90, 94, 104, 106, 111, 124, 144, 146], "pseudo": [46, 106], "y_": [46, 72, 88, 94], "fa02": [46, 67], "sr": 46, "pqrstu": 46, "phi_t": 46, "phi_u": 46, "eventu": [46, 82, 111, 144], "tda": [46, 81, 90, 94, 104, 115, 144, 146], "hhg99": [46, 67], "magnetiz": [46, 91, 150], "hold": [46, 52, 78, 82, 98, 117, 143], "sign": [46, 74, 76, 82, 88, 89, 91, 96, 98, 120, 144, 157], "dipmom_explicit": 46, "unrelax": [46, 143], "proper": [46, 82, 90, 143], "hrdh19": [46, 67, 72], "oppenheim": [47, 55, 100], "util": 47, "respond": [47, 111], "instantli": 47, "unsurprisingli": 47, "trajectori": [47, 55, 60, 155, 156], "sacrif": 47, "nuanc": 47, "strip": 47, "awai": [47, 65, 143, 144, 149], "primarili": [47, 54, 102, 140, 143], "ethan": [47, 133, 136], "k_l": 47, "incap": 47, "distort": [47, 99, 111], "replic": 47, "sampl": [47, 67, 74, 76, 91, 98, 117, 133, 142, 144], "temperatu": 47, "hardli": 47, "mol_vlx": [47, 145], "bas_vlx": [47, 145], "bond_indx": 47, "2600": 47, "550": [47, 144], "addmodelsasfram": [47, 59, 62, 92, 154, 156], "bond_xyz": 47, "anim": [47, 59, 62, 65, 92, 130, 131, 132, 154, 156], "backandforth": [47, 62, 65, 130, 131, 132, 156], "harm_func": 47, "l0": [47, 81], "stiff": 47, "opt_harm1": 47, "025": [47, 60, 101, 124, 143], "i_min_d": 47, "i_max_d": 47, "opt_harm2": 47, "i_min_": 47, "i_max_": 47, "opt_harm3": 47, "spline": [47, 58, 124, 142, 144], "275": [47, 90], "symm": 47, "167": [47, 100], "9888": 47, "157": [47, 90, 136], "10094": 47, "158": [47, 90], "160": [47, 62, 100, 148], "unrealist": [47, 105], "steeper": 47, "mors": [47, 100], "d_e": 47, "theta_0": 47, "overli": 47, "simplist": 47, "angle_scan": 47, "hd5": 47, "pdb": [47, 154, 159], "txt": [47, 70, 131], "discard": [47, 80, 144], "water_mol_str": [47, 106, 124, 143, 144, 145, 148, 153, 157], "dirver": [47, 131], "grad_drv": [47, 52], "scfgradientdriv": [47, 52, 65, 131], "angle_a": 47, "angle_": 47, "angle_xyz": 47, "opt_molecul": 47, "angle_indx": 47, "vlx2py3d": 47, "outpyt": 47, "readabl": [47, 136], "b2a": 47, "5291772": 47, "backandfirth": 47, "i_min_a": 47, "i_max_a": 47, "opt_harm_angl": 47, "150": [47, 62, 67, 72, 76, 89, 98, 122, 148], "135": [47, 67, 156], "108": [47, 100, 156], "814": [47, 120], "126546": 47, "110": [47, 62, 67, 156], "compress": [47, 55, 143, 149], "steep": 47, "bigl": 47, "bigr": 47, "behaviour": [47, 55, 101, 142], "temperatur": [47, 55, 74, 76, 89, 100, 150], "central": [47, 150], "twist": [47, 102, 120], "fourth": [47, 76, 83, 88], "fourier": [47, 88, 99], "period": [47, 55, 67, 143, 149], "mm3": 47, "charmm": 47, "barrier": [47, 67, 92], "recreat": 47, "ethane_mol_str": 47, "7616375820": 47, "0145603421": 47, "1557300969": 47, "5072801711": 47, "8786350299": 47, "dihed_a": 47, "dihed_": 47, "dihed_xyz": 47, "dihedral_scan": 47, "1f77b4": 47, "600": [47, 59, 62, 101, 120, 131, 132, 133, 154, 156], "costli": [47, 53, 147], "md": [47, 53, 54, 55, 62, 155, 156], "cut": 47, "off": [47, 113, 115, 117, 124, 143, 144, 148, 149], "lennard": 47, "jone": [47, 74], "epsilon_0": [47, 61, 76, 89], "favour": 47, "deal": [47, 49, 55, 56, 69], "ionic": 47, "noindent": 47, "bottom": [47, 113], "pragmat": 47, "elong": [47, 120], "formaledehyd": 47, "hard": [47, 55, 128, 144, 149, 153], "aforement": [48, 82, 88], "resort": [49, 91], "y_0": 49, "anymor": 49, "previous": [49, 52, 84, 141, 143, 144, 149], "pksb79": [49, 67], "hf_gradient_in_ao": 49, "hf_hessian_popl": 49, "boil": 49, "rearrang": [49, 55, 74], "nee09": [49, 67], "derivative_hf_equ": 49, "ansatz": 49, "perturbed_mo_coeffici": 49, "sc": [49, 144], "subscript": [49, 66, 72], "derivative_fock_matrix": 49, "dfa02": [49, 67], "rh": 49, "arbitrari": [49, 50, 52, 60, 96, 144], "perturbed_dens": 49, "hf_hessian_furch": 49, "jq": 49, "proced": 49, "ir": [49, 66, 100, 129, 156], "mix": [49, 61, 76, 102, 122, 142, 144, 148, 149, 150], "disadvantag": [50, 60], "global": [51, 52, 55, 56, 134, 143, 144, 148], "fluoresc": [52, 123, 141, 144], "rp16": [52, 67], "w_a": 52, "beween": 52, "taylor": [52, 55, 100, 108, 111], "v_i": 52, "un": 52, "kr16": [52, 67], "shepard": 52, "2q": 52, "confid": 52, "overview": [52, 144], "molecule_str": [52, 130], "grad_result": 52, "hess_drv": 52, "scfhessiandriv": [52, 130, 131, 132], "hess_result": 52, "z_matrix": 52, "internal_coordin": 52, "elif": [52, 60, 70, 130, 131, 132, 156], "get_b_matrix": 52, "n_atom": 52, "n_cart": 52, "n_int": 52, "b_matrix": 52, "deriv_q": 52, "spot": [52, 82], "atom_index": 52, "b_mat": 52, "bb": [52, 143], "carefulli": [52, 128, 149], "g_mat": 52, "diagnoal": 52, "g_val": 52, "g_vec": 52, "eig": [52, 106, 113, 115, 148], "g_val_invers": 52, "g_val_inverse_mat": 52, "g_minu": 52, "get_g_minu": 52, "get_b2_matrix": 52, "b2_matrix": 52, "second_deriv_q": 52, "second_deriv": 52, "atom_index_a": 52, "atom_index_b": 52, "convert_gradient_to_intern": 52, "gradient_q": 52, "grad_x": 52, "grad_q": 52, "convert_hessian_to_intern": 52, "gradq_b2mat": 52, "ixi": 52, "hessian_q": 52, "convers": [52, 66, 70, 84, 86, 91, 123, 124, 125, 144, 145], "coordiant": 52, "cart_gradi": 52, "cart_hessian": 52, "new_molecul": 52, "new_scf_drv": 52, "new_scf_result": 52, "new_scf_grad_drv": 52, "new_scf_hessian_drv": 52, "n_data_pt": 52, "int_gradi": 52, "int_hessian": 52, "hess_x": 52, "b2_mat": 52, "hess_q": 52, "get_harmonic_potenti": 52, "g_a": 52, "h_a": [52, 80], "new_q": 52, "coords_a": 52, "get_internal_coordinates_arrai": 52, "cart_coord": 52, "q_list": 52, "molec": 52, "harmonic_potenti": 52, "get_interpolated_p": 52, "new_point": 52, "data_point": 52, "sum_weight": 52, "n_point": 52, "new_energi": 52, "im_energi": 52, "qm_point": 52, "dimgrei": 52, "im": [52, 91], "ymin": [52, 131, 156], "ymax": [52, 131, 156], "eg": 52, "unless": 53, "todai": 53, "newtonian": [53, 150], "emul": [53, 55, 148], "award": 53, "assembl": 53, "reparameter": 53, "ensembl": 53, "meantim": 54, "justin": 54, "lemkul": 54, "molssi": 54, "canada": 54, "gromac": 54, "openmm": [54, 62], "mdanalysi": 54, "mdtraj": 54, "kept": [55, 60, 143], "maintain": [55, 101], "accumul": 55, "drift": 55, "thermal": [55, 76], "heat": [55, 92], "bath": 55, "maxwel": 55, "boltzmann": [55, 89, 150], "rescal": 55, "criterion": 55, "berendsen": 55, "tau": [55, 105, 113, 150, 153], "reproduc": [55, 84, 89, 91, 149], "rightarrow": [55, 75, 76, 82, 89, 91, 92, 108, 113, 136, 142, 143, 144, 146], "infin": 55, "quick": [55, 60, 145], "equilibr": 55, "andersen": 55, "nos\u00e9": 55, "hoover": 55, "stochast": 55, "artifici": [55, 101], "pressur": [55, 74, 150], "regul": 55, "piston": 55, "nabla_j": 55, "jerk": 55, "hspace": 55, "1mm": 55, "THe": 55, "dealt": 55, "neither": [55, 72, 113], "nor": [55, 72, 113], "alter": [55, 105], "evid": [55, 91], "role": [56, 67, 74], "360": 58, "scan_energi": 58, "scan_geometri": 58, "e_min_in_au": [58, 59], "energy_scan": 58, "deepskyblu": 58, "shadow": 58, "loc": [58, 124, 142, 157], "set_titl": 58, "energies_in_kcalpermol": 59, "join": [59, 124, 142, 144], "opt_geometri": 59, "forward": [59, 92, 128, 149, 154, 156], "cafestol": 59, "kahweol": [59, 156], "robusta": 59, "arabica": 59, "coffe": 59, "bean": 59, "cafestol_xyz": 59, "5215": 59, "3455": 59, "4926": 59, "2905": 59, "0812": [59, 156], "7033": 59, "1630": [59, 156], "4345": 59, "1101": [59, 156], "2807": 59, "7511": 59, "0465": [59, 156], "5244": 59, "5810": [59, 65], "4102": 59, "9909": 59, "6610": 59, "0407": [59, 156], "9440": 59, "2916": 59, "2866": 59, "8143": 59, "7311": 59, "3945": 59, "6188": 59, "8159": 59, "8642": 59, "7116": 59, "2387": [59, 156], "0606": [59, 156], "4332": [59, 156], "0024": [59, 81, 156], "3283": 59, "3742": 59, "8303": 59, "0654": [59, 156], "6844": 59, "6873": 59, "3206": 59, "6833": 59, "1309": 59, "9155": 59, "1913": [59, 144, 145, 156], "7285": 59, "8344": 59, "7277": 59, "1437": 59, "9261": 59, "5588": 59, "1644": 59, "6155": [59, 156], "2085": 59, "6490": [59, 156], "7442": 59, "6282": 59, "2525": 59, "9378": 59, "4590": 59, "8298": 59, "5879": 59, "2856": [59, 67], "1654": [59, 156], "5888": 59, "0140": [59, 156], "3604": 59, "9015": 59, "0689": [59, 156], "4604": 59, "5817": 59, "5108": 59, "5646": 59, "2626": [59, 156], "1897": [59, 156], "0861": [59, 156], "4449": 59, "1498": [59, 156], "1902": [59, 156], "7145": 59, "7003": 59, "5286": [59, 156], "2495": 59, "7981": 59, "8534": 59, "8505": 59, "1460": [59, 156], "3943": 59, "1694": [59, 156], "4136": 59, "9135": 59, "8938": 59, "0946": [59, 156], "9810": 59, "0650": [59, 156], "9487": [59, 72], "7587": 59, "7222": 59, "0818": [59, 156], "5605": 59, "7646": 59, "4951": 59, "7642": [59, 156], "9154": 59, "0477": [59, 156], "1082": [59, 156], "4431": 59, "0635": [59, 156], "0176": [59, 125, 156], "9046": 59, "2859": [59, 156], "5276": 59, "8282": 59, "1118": [59, 156], "2808": [59, 156], "8061": 59, "4944": 59, "5851": 59, "6842": 59, "8068": 59, "5898": 59, "8173": 59, "8670": 59, "8147": 59, "0892": [59, 156], "1727": [59, 156], "1832": 59, "0992": [59, 156], "8532": 59, "1337": [59, 156], "6158": 59, "0351": [59, 156], "4265": [59, 156], "0934": [59, 156], "0595": [59, 156], "4273": 59, "5264": 59, "4487": 59, "7385": 59, "4646": 59, "2871": 59, "9519": 59, "0832": [59, 156], "0442": [59, 156], "6573": 59, "1180": [59, 156], "7603": 59, "6874": 59, "3370": 59, "3869": 59, "2031": 59, "2186": [59, 156], "kahweol_xyz": [59, 156], "4710": 59, "5361": 59, "0905": [59, 156], "9753": [59, 113], "0811": [59, 156], "1625": [59, 156], "5695": [59, 156], "0997": [59, 156], "2209": 59, "8317": [59, 156], "2017": [59, 67, 156], "4821": [59, 156], "5357": 59, "4703": 59, "0038": [59, 156], "1167": [59, 156], "0462": [59, 156], "8514": 59, "8737": 59, "1997": 59, "4967": 59, "9058": [59, 156], "1119": [59, 156], "9884": 59, "6333": 59, "0944": [59, 156], "6676": 59, "3924": 59, "2474": 59, "3220": 59, "0551": [59, 156], "4569": 59, "3919": 59, "7479": 59, "1363": [59, 156], "4167": 59, "5304": 59, "9816": 59, "7435": 59, "6786": 59, "3542": 59, "0741": [59, 72, 156], "9483": 59, "1552": 59, "0367": [59, 76, 91, 156], "8330": 59, "6293": 59, "5845": 59, "5870": 59, "9677": 59, "7610": 59, "8511": 59, "4907": 59, "2146": 59, "5444": 59, "1013": 59, "8722": 59, "6493": 59, "8167": 59, "6946": 59, "3059": 59, "2309": [59, 156], "4546": 59, "2464": 59, "3980": [59, 156], "7259": 59, "2399": [59, 156], "3415": 59, "5842": 59, "5631": 59, "6779": 59, "0397": [59, 156], "9072": [59, 156], "1861": 59, "6021": [59, 156], "0159": [59, 125, 156], "2356": [59, 156], "8757": 59, "4322": 59, "3648": 59, "3090": 59, "0216": [59, 156], "9384": 59, "4328": [59, 100], "2098": [59, 156], "1924": [59, 156], "5413": 59, "8043": 59, "9694": 59, "0890": [59, 156], "9406": 59, "0514": [59, 156], "8134": 59, "0921": [59, 156], "9341": 59, "7452": 59, "9434": 59, "2193": [59, 156], "2709": 59, "8849": 59, "6699": 59, "7251": 59, "4553": 59, "0259": [59, 156], "9792": 59, "2481": [59, 156], "6508": 59, "8307": 59, "1490": [59, 156], "0518": [59, 156], "9842": 59, "4166": 59, "6762": 59, "9486": 59, "7233": 59, "0489": [59, 156], "1864": [59, 156], "0524": [59, 156], "1195": [59, 156], "8415": 59, "0679": [59, 156], "4861": 59, "3088": 59, "2088": [59, 156], "7568": 59, "7218": 59, "0925": [59, 156], "2746": [59, 156], "7905": 59, "6240": 59, "7536": 59, "1386": [59, 156], "5085": 59, "4650": [59, 156], "2132": [59, 105], "2149": [59, 113, 156], "0339": [59, 156], "4308": 59, "9731": 59, "4374": 59, "subtl": 59, "opt_cafestol_result": 59, "opt_kahweol_result": 59, "viewergrid": [59, 62, 65, 70, 131, 132, 133, 136, 139, 156, 157, 159], "250": [59, 62], "review": [60, 67, 69], "sny05": [60, 67], "path": [60, 62, 92, 105, 153], "pathpatch": 60, "bohr_in_angstrom": [60, 130, 131, 132, 156], "graphic": [60, 67, 133], "wirefram": 60, "transluc": 60, "plot_wirefram": 60, "plot_surfac": 60, "cmap": [60, 70], "viridi": [60, 70], "view_init": 60, "set_zlabel": 60, "x1": [60, 70, 81, 106, 130, 142, 148], "saddl": [60, 64], "x2": [60, 106, 142, 148], "x3": [60, 106], "repeatedli": 60, "k_i": [60, 66], "adjust": [60, 157], "grad_f": 60, "partial_x": 60, "partial_i": 60, "gradient_desc": 60, "x0": [60, 70, 81], "y0": [60, 81], "f0": [60, 70, 78, 100], "g0": 60, "grad_norm": 60, "opt_data": 60, "function_valu": 60, "gradient_norm": 60, "gradient_descent_opt_data": 60, "traj_gradient_desc": 60, "pcolormesh": 60, "traj": 60, "facecolor": [60, 120], "xpath": 60, "ypath": 60, "add_patch": 60, "histori": 60, "gamma_i": 60, "fletcher": 60, "reev": 60, "polak": 60, "ribier": 60, "conjugate_gradi": 60, "g0_norm": 60, "g_norm": 60, "error_txt": 60, "valueerror": 60, "cg_fletcher_reeves_opt_data": 60, "cg_polak_ribiere_opt_data": 60, "118": [60, 67, 76, 156], "hierarchi": [60, 75], "hessian_f": 60, "partial_xx": 60, "partial_xi": 60, "partial_yx": 60, "partial_yi": 60, "newton_raphson": 60, "trust_radiu": 60, "trust": 60, "inv_h0": 60, "delta_r": 60, "steplen": 60, "inv_h": 60, "newton_raphson_opt_data": 60, "nearest": 60, "graph": [60, 70, 91], "broyden": 60, "goldfarb": 60, "shanno": 60, "differet": 60, "hdlc": 60, "extent": [60, 74, 142], "influenc": [60, 69, 84, 101, 111, 126, 132, 141, 143, 148], "projector": 60, "infrar": [61, 67, 103, 129, 130], "Their": [61, 91], "r_k": 61, "electric_dipole_mo": 61, "cpscf": 61, "electronic_dipole_deriv": 61, "cart": [61, 66], "q_k": [61, 130, 132], "tdhf": [61, 104, 111, 113, 126, 143, 144], "tddft": [61, 81, 104, 105, 108, 111, 113, 123, 126, 128, 141, 143, 146, 149, 153], "rf07": [61, 67], "incid": [61, 89, 117], "gut19": [61, 67], "sigma_k": [61, 130, 151], "omega_k": [61, 151], "radiat": [61, 69, 74, 82, 89, 91, 103, 129, 130, 142, 150], "s_k": 61, "frac19": 61, "depolar": [61, 89], "pol": [61, 142], "depol": 61, "ratio": [61, 89, 99, 150], "forcefieldgener": 62, "topologi": 62, "thiophen": 62, "ligand": [62, 144], "276": 62, "phi_1": 62, "phi_2": 62, "amber": 62, "forcefield": 62, "databas": 62, "pathlib": 62, "read_xyz_fil": [62, 92, 131, 156], "hs276": 62, "ff_gen": 62, "read_qm_scan_xyz_fil": 62, "1_14_15_16": 62, "27_22_21_16": 62, "fh": [62, 133], "dihedral1_xyz": 62, "dihedral2_xyz": 62, "get_xyz_str": [62, 133, 139], "u03c6": 62, "u2081": 62, "u2082": 62, "\u03c6\u2081": 62, "\u03c6\u2082": 62, "resp_chg": 62, "014967": 62, "224409": 62, "089489": 62, "551618": 62, "153050": 62, "106847": 62, "315042": 62, "165854": 62, "206441": 62, "425163": 62, "225816": 62, "039099": 62, "179377": 62, "002119": 62, "014483": 62, "043666": 62, "230202": 62, "165960": 62, "071404": 62, "188598": 62, "044661": 62, "088786": 62, "173586": 62, "175730": 62, "089376": 62, "164515": 62, "118573": 62, "150541": 62, "736497": 62, "570770": 62, "273724": 62, "144051": 62, "112846": 62, "atomtypeidentifi": 62, "atom_typ": 62, "generate_gaff_atomtyp": 62, "molecule_nam": 62, "force_field_data": 62, "dat": 62, "force_field_data_extens": 62, "11_extens": 62, "workdir": 62, "mkdir": 62, "parent": 62, "exist_ok": 62, "original_itp_fil": 62, "ffversion": 62, "02d": 62, "itp": 62, "original_top_fil": 62, "with_suffix": 62, "write_itp": 62, "me": 62, "write_top": 62, "phi_result": 62, "target_dihedr": 62, "validate_force_field": 62, "dihedral_indic": 62, "dihedral_angl": 62, "140": [62, 67, 156], "mm_scan_kjpermol": 62, "39044189": 62, "48483276": 62, "27550507": 62, "36181641": 62, "98594666": 62, "12945557": 62, "5289917": 62, "62785339": 62, "54138184": 62, "5798645": 62, "9957428": 62, "07746887": 62, "94574738": 62, "35903931": 62, "9148407": 62, "06106567": 62, "07492065": 62, "5214386": 62, "qm_scan_kjpermol": 62, "68483744": 62, "04159003": 62, "23524628": 62, "25299405": 62, "80634375": 62, "14209234": 62, "24448683": 62, "88248324": 62, "57298965": 62, "70951563": 62, "2185472": 62, "34950681": 62, "50672143": 62, "13652598": 62, "11846285": 62, "99044409": 62, "39540176": 62, "79216757": 62, "73690796": 62, "89929199": 62, "06036377": 62, "88541412": 62, "83436584": 62, "18778992": 62, "07821655": 62, "53006744": 62, "104": [62, 70, 156], "49455261": 62, "115": [62, 67, 89, 137, 143, 156], "61375427": 62, "45341492": 62, "94953918": 62, "11863708": 62, "92655945": 62, "30844116": 62, "13588715": 62, "1687088": 62, "99819183": 62, "83585497": 62, "39214553": 62, "07446008": 62, "05870708": 62, "79647248": 62, "41640576": 62, "76097693": 62, "36547258": 62, "46062129": 62, "21413969": 62, "26370882": 62, "96902213": 62, "13610802": 62, "45022189": 62, "31569068": 62, "94255437": 62, "29405596": 62, "08664149": 62, "fitted_phi_result": 62, "85865021": 62, "5467453": 62, "92016602": 62, "18968964": 62, "42712402": 62, "39407349": 62, "69501495": 62, "93608093": 62, "92350769": 62, "69535828": 62, "40233612": 62, "13204956": 62, "84503174": 62, "46120453": 62, "05204773": 62, "96090698": 62, "59947205": 62, "49703217": 62, "77013397": 62, "43408203": 62, "92618561": 62, "82312012": 62, "59525299": 62, "37159729": 62, "85509491": 62, "40908813": 62, "28764343": 62, "91279602": 62, "07723999": 62, "00006104": 62, "22518921": 62, "41876221": 62, "14795685": 62, "7151413": 62, "09519958": 62, "07654572": 62, "improved_phi_result": 62, "39545441": 62, "01393127": 62, "20561218": 62, "25416565": 62, "3174057": 62, "2179184": 62, "57676697": 62, "96492004": 62, "10110474": 62, "94235229": 62, "59909821": 62, "18383789": 62, "74294281": 62, "30089569": 62, "21685028": 62, "52063751": 62, "42159271": 62, "43003845": 62, "7759552": 62, "45406342": 62, "97280884": 62, "90036011": 62, "69313049": 62, "46485138": 62, "9087677": 62, "39290619": 62, "19385529": 62, "76613617": 62, "92942047": 62, "90858459": 62, "22563934": 62, "50617981": 62, "2787323": 62, "83068085": 62, "15373993": 62, "05529785": 62, "improved_phi_results_new": 62, "42739868": 62, "89348602": 62, "45018768": 62, "0739975": 62, "42835999": 62, "00170898": 62, "36753082": 62, "33047485": 62, "92477417": 62, "30165863": 62, "63945007": 62, "1234436": 62, "6337204": 62, "46183014": 62, "81786346": 62, "44065094": 62, "93300629": 62, "82655334": 62, "59573364": 62, "37197876": 62, "85752106": 62, "41316223": 62, "29174805": 62, "91529846": 62, "07827759": 62, "00108337": 62, "22787476": 62, "42301941": 62, "15213776": 62, "71668243": 62, "0941925": 62, "08368683": 62, "custom": [62, 144], "script": 62, "content": 62, "custom_plot": 62, "res1": 62, "title1": 62, "res2": 62, "title2": 62, "121": [62, 67, 156], "122": [62, 67, 156], "refit": 62, "target_top_fil": 62, "dihedral_correct": 62, "kt": [62, 76], "update_dihedral_rang": 62, "scan_dih_angl": 62, "raphson": 64, "quasi": 64, "bak86": [64, 67], "candid": 65, "essenc": 65, "ilustr": 65, "intrins": [65, 82], "funtion": 65, "drawxyzgeom": 65, "geom": 65, "compxyzgeom": 65, "init": 65, "geom_xyz": 65, "4059000000": 65, "8128000000": 65, "0009000000": 65, "5654000000": 65, "3926000000": 65, "0383000000": 65, "0196000000": 65, "0052000000": 65, "0386000000": 65, "4291000000": 65, "0210000000": 65, "3741000000": 65, "8940000000": 65, "0007000000": 65, "9546000000": 65, "4028000000": 65, "0003000000": 65, "4958000000": 65, "3375000000": 65, "0011000000": 65, "1970000000": 65, "3166000000": 65, "0018000000": 65, "scf_grad_drv": 65, "scf_opt_drv": 65, "_optim": 65, "48406869": 65, "48588381": 65, "3986767507": 65, "8076140878": 65, "0009002477": 65, "5554932198": 65, "3912703043": 65, "0008560542": 65, "0339417937": 65, "0131015966": 65, "0050309571": 65, "0296875775": 65, "4272388306": 65, "0208045784": 65, "3724942305": 65, "8878930527": 65, "0007271680": 65, "9523159399": 65, "3970927549": 65, "0002038018": 65, "4855076024": 65, "3246755992": 65, "0010344286": 65, "1995439420": 65, "3168060274": 65, "0019270504": 65, "48754838": 65, "3881987993": 65, "8008460851": 65, "0008959673": 65, "5414491982": 65, "3899861931": 65, "0007853320": 65, "0276095642": 65, "0039979473": 65, "0047832956": 65, "0164700299": 65, "4244073465": 65, "0205164352": 65, "3697024299": 65, "8795054853": 65, "0007658631": 65, "9489162104": 65, "3892473489": 65, "0000581691": 65, "4711152364": 65, "3064025713": 65, "0009230192": 65, "2027737500": 65, "3171424570": 65, "0021141842": 65, "48730935": 65, "2694737152": 65, "8199118237": 65, "0020300631": 65, "4650268055": 65, "3557331487": 65, "0014081365": 65, "9624886689": 65, "9369706825": 65, "0070753368": 65, "9114607569": 65, "3882275308": 65, "0242133169": 65, "2776270348": 65, "8879026382": 65, "0037766854": 65, "9579288423": 65, "3019609852": 65, "0042985096": 65, "3994930133": 65, "3005046839": 65, "0013522025": 65, "1661868246": 65, "3716732596": 65, "0018726559": 65, "48730981": 65, "2687990140": 65, "8198482259": 65, "0024123532": 65, "4652286829": 65, "3556615967": 65, "0016439073": 65, "9625706742": 65, "9373517016": 65, "0080640143": 65, "9119100993": 65, "3873539839": 65, "0265832651": 65, "2768799142": 65, "8879461569": 65, "0046771752": 65, "9591653948": 65, "3012461760": 65, "0048335460": 65, "3997144523": 65, "3008164821": 65, "0025853684": 65, "1654403884": 65, "3717101556": 65, "0012082555": 65, "gibb": 65, "1393": [65, 105, 156], "rot": [65, 75, 101, 124, 148], "vib": [65, 66], "tot": 65, "4904": 65, "8942": [65, 156], "9940": 65, "3787": [65, 156], "6717": 65, "9750": 65, "9343": 65, "6015": 65, "4925": 65, "4803": 65, "5743": 65, "e0": [65, 101], "149025": 65, "5369": 65, "zpve": 65, "02859519": 65, "9438": 65, "45871462": 65, "149007": 65, "5931": 65, "comparis": 65, "vdata_last": 65, "628": [65, 156], "204633": 65, "330398": 65, "000411": 65, "001108": 65, "368626": 65, "108966": 65, "000569": 65, "307556": 65, "056006": 65, "004238": 65, "506299": 65, "335269": 65, "039828": 65, "199547": 65, "012314": 65, "001551": 65, "295694": 65, "218857": 65, "000577": 65, "278836": 65, "133604": 65, "000508": 65, "059067": 65, "024571": 65, "001489": 65, "coord_t": 65, "freq_xyz": 65, "cm": [65, 66, 76, 82, 84, 91, 98, 100, 111, 124, 130, 131, 132, 150, 156], "freq": [65, 89, 113, 124, 142, 144, 156], "coord_freq": 65, "ts_vib": 65, "02204438e": 65, "55006529e": 65, "46487032e": 65, "46548310e": 65, "66187114e": 65, "03128041e": 65, "40019156e": 65, "87717400e": 65, "23011918e": 65, "56975291e": 65, "98815248e": 65, "50289216e": 65, "03586415e": 65, "54443109e": 65, "17695454e": 65, "14350535e": 65, "87257868e": 65, "02244501e": 65, "28227452e": 65, "71066186e": 65, "92565734e": 65, "09074270e": 65, "55997931e": 65, "30530216e": 65, "ddagger": 65, "react": 65, "Will": [65, 147], "52638154": 65, "9112351040": 65, "1624677572": 65, "0006980640": 65, "0548281772": 65, "0782577796": 65, "0004981290": 65, "3015267488": 65, "8281271773": 65, "0008357891": 65, "8259069457": 65, "7432222546": 65, "0231535592": 65, "8632242900": 65, "3826709271": 65, "0017612332": 65, "0964503076": 65, "2975291731": 65, "0015528206": 65, "9848455585": 65, "9798798745": 65, "0056716903": 65, "2831586608": 65, "0548212877": 65, "0000093104": 65, "tst": 65, "50434988": 65, "149036": 65, "2297": [65, 156], "g_t": 65, "g_reac": 65, "delta_g": [65, 122], "eyr": 65, "k_b": 65, "958e": 65, "3806e": 65, "6261e": 65, "202e": 65, "irc_forw_xyz": 65, "26880": 65, "81980": 65, "00240": [65, 75], "46520": 65, "35570": 65, "00160": 65, "55580": 65, "91590": 65, "00620": 65, "50510": 65, "36590": 65, "02850": 65, "27690": 65, "88790": 65, "00470": 65, "95920": 65, "30120": 65, "00480": 65, "00710": 65, "32220": 65, "00070": 65, "75870": 65, "39310": 65, "00310": [65, 75], "artifact": 65, "prod_xyz": 65, "pentacycl": 65, "72239707": 65, "8617419369": 65, "8032549747": 65, "0043906460": 65, "2297358489": 65, "4963316637": 65, "0026018408": 65, "5141177188": 65, "7772456796": 65, "0085738694": 65, "1667292050": 65, "5672508556": 65, "0149134240": 65, "4243082245": 65, "7254211048": 65, "0060026334": 65, "2182366655": 65, "9261003405": 65, "0078164842": 65, "0829962370": 65, "3043435852": 65, "0024523167": 65, "9785719893": 65, "5290970262": 65, "0043900689": 65, "9789": 65, "4011": [65, 156], "7857": 65, "0801": [65, 156], "7246": 65, "4763": 65, "2240": [65, 156], "5174": 65, "3429": 65, "149173": 65, "0564": [65, 156], "04051209": 65, "4217": 65, "68188498": 65, "149147": 65, "6346": 65, "g_prod": 65, "reac_g": 65, "deciu": [66, 67], "wdc80": [66, 67], "hessian_matrix_el": 66, "x_i": [66, 70], "coordiat": 66, "deri": 66, "mwc": 66, "m_1": 66, "m_n": 66, "m_i": [66, 91], "hessian_mwc": 66, "center_of_mass": [66, 81], "inertia": 66, "eckart": [66, 67], "eck35": [66, 67], "gram": [66, 72], "schmidt": [66, 72], "six": [66, 82, 97, 124, 125], "hessian_to_intern": 66, "hessian_internal_diagon": 66, "lambda_i": [66, 94], "nu_i": 66, "wavenumb": [66, 130, 131, 132, 156], "reciproc": 66, "centimet": 66, "vibrations_wavenumb": 66, "undo": 66, "spectral": [66, 70, 73, 150], "reduced_mass": [66, 100], "force_const": 66, "raman": [66, 67, 129, 141], "adj21": [67, 149], "ambrois": 67, "jensen": 67, "2832": 67, "2021": [67, 156], "url": [67, 133], "jctc": 67, "1c00042": 67, "bs71": [67, 144], "bagu": 67, "schaefer": 67, "artre": 67, "ock": 67, "1474": [67, 156], "1971": [67, 156], "1063": [67, 156], "1676248": 67, "baker": 67, "385": 67, "395": [67, 143], "1986": 67, "1002": [67, 156], "jcc": 67, "540070402": 67, "bar04": [67, 82, 91], "laurenc": [67, 91], "barron": [67, 91], "cambridg": 67, "2004": 67, "1017": [67, 156], "cbo9780511535468": 67, "bayli": 67, "cieplak": 67, "cornel": 67, "pub": 67, "j100142a004": 67, "rev": 67, "3098": 67, "3100": 67, "1103": [67, 124, 156], "physreva": 67, "thermochemistri": 67, "5648": 67, "5652": [67, 156], "464913": 67, "byy17": [67, 141], "bergmann": 67, "yachandra": 67, "yano": 67, "laser": [67, 76, 82, 96, 111, 117, 148], "biologi": 67, "societi": 67, "isbn": 67, "84973": 67, "1039": [67, 156], "9781782624097": 67, "besler": 67, "semiempir": 67, "431": 67, "439": 67, "onlinelibrari": 67, "wilei": 67, "540110404": 67, "bes12": [67, 149], "beslei": 67, "lett": 67, "542": [67, 144], "2012": 67, "1016": [67, 144, 145, 156], "cplett": 67, "bes21": [67, 144], "wire": 67, "sci": 67, "wcm": 67, "1527": 67, "ba10": [67, 144, 149], "asmuruf": 67, "12024": 67, "12039": 67, "2010": [67, 156], "c002207a": 67, "curt": 67, "breneman": 67, "kenneth": 67, "wiberg": 67, "monopol": [67, 84], "formamid": 67, "540110311": 67, "buc67": [67, 84], "buckingham": [67, 74, 84, 91], "adv": 67, "1967": [67, 156], "9780470143582": 67, "ch2": [67, 142], "caldeweyh": 67, "ehlert": 67, "hansen": 67, "neugebau": 67, "spicher": 67, "bannwarth": 67, "ondon": 67, "154122": 67, "2019": 67, "5090222": 67, "cds80": [67, 69, 144], "cederbaum": 67, "domck": 67, "schirmer": 67, "206": 67, "cen15": [67, 130], "centron": 67, "diffract": 67, "annu": 67, "anal": 67, "101": [67, 150, 156], "126": [67, 89, 156], "2015": [67, 156], "1146": [67, 156], "annurev": 67, "anchem": 67, "071114": 67, "040435": 67, "multimolecul": 67, "multiconform": 67, "methodologi": 67, "biopolym": 67, "dna": 67, "rna": 67, "1357": 67, "1377": [67, 156], "1995": [67, 156], "540161106": 67, "cohen": 67, "mori": 67, "s\u00e1nchez": 67, "289": [67, 142], "320": 67, "cr200107z": 67, "deglmann": 67, "furch": 67, "ahlrich": 67, "362": [67, 124, 144], "511": 67, "518": [67, 106, 148], "2002": [67, 156], "s0009": 67, "2614": 67, "01084": 67, "phenomena": [67, 74, 113], "homa": 67, "math": 67, "proc": 67, "camb": 67, "philo": 67, "soc": 67, "376": 67, "1930": 67, "s0305004100016108": 67, "gordon": 67, "4009": [67, 156], "4037": 67, "2005": [67, 156], "cr0505627": 67, "wormit": [67, 70], "1206": [67, 156], "polyatom": 67, "552": [67, 70, 150], "558": [67, 144], "1935": [67, 156], "physrev": 67, "ekstromncaagren06": [67, 144], "ekstr": 67, "\u00f6": 67, "carravetta": 67, "gren": 67, "2006": 67, "physrevlett": 67, "143001": 67, "erdew": 67, "urk": 67, "rnzerhof": 67, "5029": 67, "5036": [67, 156], "1999": 67, "478401": 67, "foresman": 67, "popl": 67, "1992": [67, 156], "j100180a030": 67, "fpb18": [67, 144], "fouda": 67, "purnel": 67, "ultra": 67, "reson": [67, 113, 117, 129, 141, 143, 145], "inelast": [67, 129, 141], "2586": 67, "2595": [67, 100], "2018": [67, 76, 89, 98, 148, 156], "8b00211": 67, "fbv": [67, 149], "vidal": 67, "coriani": 67, "xaboom": 67, "nitrogen": 67, "1618": [67, 156], "0c01082": 67, "fbn16": [67, 143], "burdakova": 67, "edg": [67, 69, 141, 143, 144, 148, 149], "silicon": [67, 143, 150], "germanium": 67, "sulfur": 67, "compound": [67, 86, 88, 92, 100, 143, 149], "damp": [67, 76, 83, 89, 98, 113, 124, 142, 143, 144], "13591": 67, "13603": 67, "2016": 67, "c6cp00561f": 67, "fd19": [67, 144, 149], "546": 67, "556": 67, "8b01046": 67, "fbr14": [67, 82], "daniel": 67, "fries": 67, "maarten": 67, "beerepoot": 67, "ruud": 67, "multiphoton": [67, 117], "204103": 67, "2014": [67, 70], "4901563": 67, "adiabat": [67, 99, 100, 111], "117": [67, 156], "7433": 67, "7447": 67, "1508368": 67, "g\u00f6rling": 67, "2783": 67, "2799": [67, 156], "gagliardi": 67, "lindh": 67, "karlstr": 67, "rop": 67, "4494": 67, "4500": 67, "1778131": 67, "gbg08": [67, 144], "gilbert": 67, "gill": 67, "mom": [67, 143, 144, 145, 148, 150], "13164": 67, "13171": 67, "2008": [67, 156], "jp801738f": 67, "antoni": 67, "ehrlich": 67, "krieg": 67, "154104": 67, "guthmul": 67, "497": 67, "son": 67, "ltd": 67, "9783527814596": 67, "ch17": 67, "hhgb18": [67, 149], "hanson": 67, "hein": 67, "georg": 67, "699": 67, "hat06": [67, 71], "hattig": 67, "nanosci": 67, "245": 67, "278": 67, "juser": 67, "fz": 67, "juelich": 67, "record": 67, "152600": 67, "fzj": 67, "02217": 67, "pdf": [67, 159], "hggmw95": [67, 153], "grana": 67, "mauric": 67, "white": [67, 133, 159], "attach": [67, 105, 125, 126, 145], "detach": [67, 105, 125, 126, 145], "14261": 67, "j100039a012": 67, "helgak": 67, "j\u00f8rgensen": 67, "183": 67, "s0065": 67, "3276": 67, "60616": 67, "olsen": [67, 75], "9781119019572": 67, "hf20": [67, 69, 144], "herbst": 67, "quantifi": 67, "153": [67, 125], "054114": 67, "2020": [67, 156], "0013538": 67, "dyke": 67, "ortenburg": 67, "statist": 67, "807": 67, "811": 67, "1969": 67, "hirata": 67, "amm": 67, "ancoff": 67, "314": 67, "291": [67, 150], "299": [67, 143, 144], "01149": 67, "hdsd22": [67, 72], "dempwolff": 67, "156": [67, 125], "074104": 67, "0070967": 67, "rehn": 67, "h\u00f6fener": 67, "164125": 67, "aip": 67, "scitat": 67, "5093606": 67, "136": [67, 136, 156], "b864": 67, "b871": 67, "hlumartinez15": [67, 71], "hohenstein": 67, "luehr": 67, "ufimtsev": 67, "mart": 67, "\u00ed": 67, "nez": 67, "142": [67, 150], "224103": 67, "4921956": 67, "kkg": [67, 143], "kadek": 67, "konecni": 67, "gao": 67, "repiski": 67, "irac": 67, "ohn": 67, "22566": 67, "22570": 67, "c5cp03712c": 67, "kie72": [67, 84], "kielich": 67, "isotop": 67, "dielectr": [67, 89, 91], "davi": 67, "editor": [67, 133], "specialist": 67, "report": 67, "192": 67, "1972": [67, 156], "kim": 67, "bacteriochlorophyl": 67, "enna": 67, "atthew": 67, "lson": 67, "5235": 67, "5246": 67, "6b00647": 67, "ksk": [67, 144], "king": 67, "stanton": 67, "wyatt": 67, "nonorthogon": 67, "1936": [67, 156], "1712221": 67, "koj95": [67, 89], "kirpekar": 67, "oddershed": 67, "103": [67, 100, 125, 156], "2983": 67, "470486": 67, "a1133": 67, "a1138": 67, "klp": [67, 144], "kowalska": 67, "lima": 67, "pollock": 67, "ree": 67, "debeer": 67, "bioinorgan": 67, "isr": [67, 68, 72, 73], "803": 67, "815": 67, "ijch": 67, "201600037": 67, "lle": 67, "alvetti": 67, "789": [67, 156], "physrevb": 67, "levchenko": 67, "substitut": [67, 131, 142, 143], "phd": 67, "thesi": 67, "southern": 67, "california": 67, "wang": 67, "krylov": 67, "224106": 67, "1877072": 67, "natl": 67, "acad": 67, "6062": [67, 156], "6065": 67, "1979": [67, 156], "1073": [67, 156], "pna": 67, "606": 67, "lpl": [67, 80], "parrish": 67, "liu": 67, "kokkila": 67, "schumach": 67, "exciton": [67, 94, 102, 103, 105], "3493": 67, "3504": 67, "7b00171": 67, "lvkkg12": [67, 144], "lopata": 67, "kuiken": 67, "khalil": 67, "govind": 67, "3284": 67, "3292": 67, "ct3005613": 67, "ls61": [67, 144], "lyko": 67, "schmeis": 67, "288": [67, 113], "1961": [67, 156], "1731901": 67, "263": 67, "60318": 67, "mar03": [67, 94], "richard": 67, "martin": 67, "4775": 67, "4777": 67, "1558471": 67, "mat92": [67, 73], "mattuck": 67, "diagram": [67, 70, 73, 123], "courier": 67, "corpor": 67, "ms96": [67, 72], "mertin": 67, "biorthogon": 67, "2140": 67, "2152": [67, 156], "1996": [67, 156], "nees": 67, "253": 67, "563": 67, "2009": [67, 156], "ccr": 67, "et": [67, 88], "al": [67, 72], "orca": 67, "nbjo01": [67, 144], "bishop": 67, "Near": 67, "10323": 67, "10334": 67, "1415081": 67, "nd18": [67, 69, 141, 144, 149], "7208": 67, "7248": 67, "chemrev": 67, "8b00156": 67, "nrs18": [67, 78, 88, 99, 108, 113, 130], "saue": 67, "nl14": [67, 102], "patrick": 67, "mathieu": 67, "linar": 67, "circular": [67, 89, 91, 102, 117, 148], "dichroism": [67, 82, 89, 102, 148], "\u03c0": 67, "stack": [67, 102, 105], "ethylen": [67, 94, 96, 102, 105, 113, 115], "483": 67, "489": 67, "chir": 67, "22331": 67, "pmk21": [67, 149], "paul": 67, "myhr": 67, "koch": 67, "cc3": [67, 128, 149], "0c00686": 67, "pbapplerwd14": [67, 153], "plasser": [67, 70], "\u00e4": 67, "ppler": 67, "pplicat": 67, "024107": 67, "4885820": 67, "pwd14": [67, 153], "ormal": 67, "024106": [67, 70], "4885819": 67, "krishnan": 67, "schlegel": 67, "binklei": 67, "m\u00f8": 67, "ller": 67, "lesset": 67, "225": 67, "241": 67, "qua": 67, "560160825": 67, "pulai": 67, "393": [67, 90], "398": 67, "0009": [67, 156], "80396": 67, "560": 67, "1982": [67, 156], "540030413": 67, "fogarasi": 67, "2860": [67, 156], "462844": 67, "rappoport": 67, "aman": 67, "201104": 67, "2007": [67, 156], "2744026": 67, "heidelberg": 67, "174110": 67, "5085117": 67, "scheurer": 67, "brand": 67, "1528": 67, "park": 67, "ion": [67, 144], "quant": 67, "116": [67, 98, 156], "573": 67, "577": 67, "25064": 67, "vahtra": 67, "ahmadzadeh": 67, "ringholm": 67, "scott": 67, "velox": 67, "hem": 67, "ython": 67, "e1457": 67, "1457": 67, "sch82": [67, 73], "2395": [67, 156], "2416": [67, 81], "sch91": [67, 72], "4647": 67, "4659": 67, "1991": [67, 156], "sm10": [67, 72], "theor": 67, "acc": 67, "125": [67, 70, 156], "172": [67, 100], "springer": 67, "1007": [67, 156], "s00214": 67, "009": 67, "0597": [67, 156], "st04": [67, 72], "trofimov": 67, "11449": 67, "11464": 67, "1752875": 67, "harrel": 67, "seller": 67, "560450106": 67, "458": [67, 70], "468": 67, "4684": 67, "1890": 67, "3_36": 67, "shavitt": 67, "bartlett": 67, "mbpt": 67, "cbo9780511596834": 67, "sh07": [67, 130], "siebert": 67, "hildebrandt": 67, "9783527621347": 67, "chandra": 67, "singh": 67, "peter": 67, "540050204": 67, "snyman": 67, "stephen": [67, 76, 89, 98, 148], "devlin": [67, 76, 89, 98, 148], "chabalowski": [67, 76, 89, 98, 148], "frisch": [67, 76, 89, 98, 148], "11623": [67, 76, 89, 98, 148], "11627": 67, "1994": [67, 76, 89, 98, 148, 156], "j100096a001": 67, "stratmann": 67, "257": 67, "213": 67, "223": [67, 90, 124, 143, 144], "00600": 67, "stohr92": [67, 69], "hr": 67, "nexaf": [67, 144], "busi": 67, "media": [67, 82], "szabo": 67, "ostlund": 67, "climb": 67, "nonempir": 67, "meta": 67, "146401": 67, "treutler": 67, "102": [67, 76, 156], "346": 67, "354": 67, "469408": 67, "vbl16": [67, 141], "bokhoven": 67, "laberti": 67, "9781118844236": 67, "9781118844243": 67, "vfe": [67, 144, 149], "feng": 67, "epifanovski": 67, "3117": 67, "3133": 67, "9b00039": 67, "vkc19": [67, 144], "dyson": [67, 144], "fc": [67, 133], "cv": [67, 68, 69, 142, 146], "eom": 67, "photoelectron": 67, "2693": [67, 156], "c9cp03695d": 67, "lenth": 67, "duijneveldt": 67, "643": 67, "651": 67, "459511": 67, "nusair": 67, "liquid": [67, 74, 82], "1211": [67, 156], "1139": [67, 156], "p80": 67, "159": [67, 83], "wagniere82a": [67, 82], "wagni": 67, "\u00e9": 67, "2786": 67, "444166": 67, "wagniere82b": [67, 82], "473": [67, 70], "442747": 67, "song": 67, "214108": 67, "4952956": 67, "yu": 67, "8487": 67, "8492": [67, 156], "1705670114": 67, "wbm": [67, 144], "weinhardt": 67, "benkert": 67, "meyer": 67, "blum": 67, "reinert": 67, "hesk": 67, "spectat": 67, "soft": [67, 69], "144311": 67, "3702644": 67, "wen16": [67, 72], "wenzel": 67, "whwd15": [67, 144, 149], "holzer": 67, "214104": 67, "4921841": 67, "dover": 67, "york": 67, "wor09": [67, 72, 73], "harvest": 67, "goeth": 67, "frankfurt": 67, "yanai": 67, "tew": 67, "handi": 67, "attenu": [67, 98, 141], "zhao": 67, "innesota": 67, "502": 67, "2011": [67, 156], "060": 67, "lachjs04": [67, 89], "\u0142": 67, "ach": 67, "jeziorski": 67, "szalewicz": 67, "radi": [67, 123], "233001": 67, "intract": 69, "schemat": [69, 72, 73, 123], "reduct": [69, 144], "characteris": 69, "sensit": [69, 98, 141, 144], "xa": [69, 141, 142, 144, 149], "ref": [69, 102, 143], "continuum": [69, 106, 124, 141, 143], "alongsid": [69, 97, 128], "dichloroethylen": 69, "sim": [69, 111, 113, 143, 144], "290": [69, 143], "ev": [69, 70, 72, 75, 81, 90, 100, 101, 102, 105, 113, 115, 124, 125, 142, 143, 144, 145, 148, 150, 153], "speci": 69, "volt": [69, 150], "peak": [69, 130, 131, 143, 151], "inequival": 69, "pronounc": [69, 120], "polaris": 69, "counteract": [69, 143], "pi_": [70, 73], "n0": [70, 73, 75, 90, 99, 117], "gamma_n": [70, 73], "pole": [70, 73, 89], "broaden": [70, 73, 81, 124, 125, 130, 131, 142, 143, 144, 156, 158], "mathbb": 70, "mx": 70, "e_n": [70, 72, 73, 99], "mointsdriv": 70, "colormap": 70, "au2ev": [70, 75, 90, 101, 106, 124, 125, 142, 143, 144, 145, 148, 150, 151], "hartree_in_ev": [70, 81], "lih_xyz": [70, 72], "basis_set_label": [70, 72, 100, 131, 132, 143], "run_scf": [70, 72, 124, 125, 142, 144, 145, 153], "1561447194": [70, 143, 148], "963513321178": 70, "963513323402": 70, "00002852": 70, "00000681": 70, "963513323651": 70, "0000000002": [70, 120, 143], "00000905": 70, "00000208": 70, "00002371": 70, "963513323683": 70, "00000065": 70, "00000015": 70, "00001205": 70, "00000002": [70, 120, 143], "00000042": 70, "00000001": [70, 72, 120], "9635133237": 70, "1196580431": 70, "24239": 70, "26646": 70, "61559": 70, "45278": 70, "39107": 70, "60182": 70, "73721": 70, "orb_view": 70, "mo_energi": [70, 113, 143], "moints_drv": [70, 113], "nvir": [70, 81], "nexc": [70, 72, 94], "adc0_mat4d": 70, "adc1_mat4d": 70, "fill": [70, 144], "4d": 70, "adc0_mat2d": 70, "adc1_mat2d": 70, "nclose": 70, "844": 70, "868": 70, "217": 70, "353": [70, 150], "055": 70, "128": [70, 143, 156], "021": 70, "154": [70, 83, 100], "046": [70, 125], "064": 70, "504": [70, 144], "788": 70, "041": 70, "048": 70, "721": 70, "481": 70, "adc0_eigv": 70, "adc0_eigvec": 70, "adc1_eigv": 70, "adc1_eigvec": 70, "567": 70, "570": 70, "548": 70, "dimensionless": [70, 150], "frac23": 70, "adc0_tdm": 70, "adc1_tdm": 70, "cis_tdm": 70, "t2_dict": 70, "mo_occ": [70, 143, 144, 145, 148], "mo_vir": 70, "n_state": [70, 90, 101, 122, 143, 144, 145, 148], "sqrt2": 70, "gamma_adc0": 70, "t_term": 70, "gamma_adc1": 70, "gamma_ci": 70, "dipole_ints_ao": 70, "adc0_osc_str": 70, "adc1_osc_str": 70, "cis_osc_str": 70, "tdm0": 70, "tdm1": 70, "tdm_ci": 70, "f1": 70, "f_ci": 70, "xmn": 70, "lorentzian": [70, 81, 106, 124, 125, 130, 131, 132, 142, 143, 144, 148, 156], "add_broaden": [70, 130, 131, 132, 156], "xb": 70, "yb": 70, "line_profil": [70, 130, 131, 132, 156], "lorentizan": 70, "fwhm": [70, 151], "hwhm": [70, 151], "xb_move": 70, "yb_move": 70, "x_min": [70, 130, 131, 132, 156], "x_max": [70, 130, 131, 132, 156], "zeros_lik": 70, "x_adc0": 70, "y_adc0": 70, "x_adc1": 70, "y_adc1": 70, "x_ci": 70, "y_ci": 70, "darkr": 70, "grai": 70, "adc1_result": 70, "run_adc": [70, 124, 125, 142, 144, 145, 153], "adc1": [70, 143], "tol": 70, "jacobi": [70, 125], "niter": [70, 125], "n_ss": [70, 125], "max_residu": [70, 125], "ritz": [70, 125], "7186e": 70, "34m": 70, "614": 70, "701": 70, "806": 70, "220m": 70, "x_gator": 70, "y_gator": 70, "excitation_energi": [70, 81, 100, 124, 125, 142, 143, 144, 148], "oscillator_strength": [70, 81, 100, 102, 105, 106, 113, 124, 125, 142, 143, 144, 148, 151], "506": [70, 144, 156], "nci": 70, "063": 70, "095": 70, "581": 70, "052": [70, 113], "087": 70, "077": 70, "058": 70, "169": [70, 100], "705": 70, "016": [70, 125], "kappa_i": 70, "gamma_a": 70, "d_i": 70, "gamma_d": 70, "p_a": 70, "p_d": 70, "calculate_difference_dens": 70, "ddm_mo": 70, "get_attachement_detach": 70, "density_mo": 70, "density_ao": 70, "new_dens": 70, "k_ao": 70, "w_ao": 70, "k_detach": [70, 153], "k_ao_d": 70, "k_attach": [70, 153], "k_ao_a": 70, "detach_mo": 70, "attach_mo": 70, "detach_ao": [70, 153], "attach_ao": [70, 153], "mo_coeff": [70, 143, 144, 145, 148], "cube_point": 70, "cubic_grid": 70, "gen_cubic_grid": 70, "detach_adc1": 70, "attach_adc1": 70, "pd": 70, "cube": [70, 105, 153], "dens_da": 70, "detach_cube_nam": 70, "_adc1_": 70, "d_detach": 70, "attach_cube_nam": 70, "d_attach": 70, "nwrite": 70, "write_data": 70, "isoval_d": 70, "isoval_a": 70, "800": [70, 130, 157, 159], "name_d": 70, "name_a": 70, "addvolumetricdata": [70, 157], "isov": [70, 157], "09469": 70, "904": 70, "425": 70, "convention": 71, "workstat": 71, "portion": [71, 92], "facilit": 71, "eigenproblem": 71, "dd": [71, 72], "rewritten": [71, 82, 124], "elimin": [71, 84], "eigensolv": [71, 148], "precursor": 72, "isdefinit": 72, "mdef": 72, "psi_l": 72, "adc_eigenvalue_eq": 72, "my": 72, "mseri": 72, "subblock": 72, "oder": 72, "hoc": [72, 143], "imbalanc": 72, "adcmat_ph_ph_0": 72, "adcmat_ph_ph_1": 72, "adcmat_ph_ph_2": 72, "ackl": 72, "bckl": 72, "cdik": 72, "jkcd": 72, "acik": 72, "jkbc": 72, "adcmat_ph_2p2h_1": 72, "id": [72, 133], "ak": 72, "il": [72, 82], "c2p2hph_1": 72, "cj": [72, 144], "adcmat_2p2h_2p2h_0": 72, "bd": 72, "klab": 72, "jlab": 72, "jcd": 72, "ijcd": 72, "jkc": 72, "ijbd": 72, "ikac": 72, "klc": 72, "klac": 72, "klbc": 72, "kcd": 72, "ikcd": 72, "imposs": [72, 74, 89, 148], "smallest": [72, 143], "overcom": [72, 101], "secular": 72, "ucc": 72, "share": [72, 120], "jn": 72, "d_n": 72, "psi_m": 72, "_m": 72, "adconedriv": 72, "adctwodriv": 72, "lih": 72, "basis_lih": 72, "basis_h2o": 72, "scf_lih": 72, "scf_h2o": 72, "e_scf_lih": 72, "e_scf_h2o": 72, "thrice": 72, "adc1_drv": 72, "adc1_results_h2o": 72, "adc1_results_lih": 72, "adc2_drv": 72, "adc2_results_h2o": 72, "adc2_results_lih": 72, "qq_den": 72, "batch": [72, 76, 89, 98, 148], "imb": 72, "49e": 72, "36669368": 72, "11478601": 72, "44840498": 72, "13775605": 72, "46360595": 72, "14905941": 72, "52e": [72, 89], "08e": 72, "35291511": 72, "01136344": 72, "42544431": 72, "00107731": 72, "44554970": 72, "04521708": 72, "67e": [72, 76], "36e": [72, 98], "35279762": 72, "00151889": 72, "42544293": 72, "00001364": 72, "44369379": 72, "00767191": 72, "35279702": 72, "00033748": 72, "44360836": 72, "00228847": 72, "90e": [72, 148], "35279701": 72, "00000654": 72, "44360608": 72, "00088952": 72, "00000010": [72, 143], "44360599": 72, "00010839": 72, "05e": 72, "00000483": 72, "60010": 72, "osc": [72, 100, 113, 124, 125, 144, 145, 148, 151, 153], "01663": 72, "57689": 72, "07113": 72, "11240": 72, "60e": 72, "47e": 72, "15889294": 72, "01952183": 72, "20608326": 72, "01468372": 72, "21659287": 72, "03602681": 72, "28273182": 72, "01773908": 72, "33269430": 72, "01820955": 72, "33539479": 72, "02560730": 72, "15870155": 72, "00048111": 72, "20597994": 72, "20599656": 72, "00587184": 72, "28256950": 72, "00084005": 72, "33252586": 72, "33360191": 72, "04595089": 72, "15870142": 72, "00001296": 72, "00000164": 72, "28256876": 72, "00004259": 72, "00002258": 72, "69e": [72, 76], "10e": 72, "31849": 72, "02843": 72, "60500": 72, "25169": 72, "68909": 72, "04341": 72, "s5": [72, 81], "04849": 72, "02652": 72, "s6": [72, 81], "gb": [72, 76, 89, 98, 148], "spent": [72, 76, 98], "usag": 72, "73e": [72, 98, 148], "00000658": 72, "00089376": 72, "11e": 72, "00011110": 72, "59e": 72, "00000459": 72, "1274706653": 72, "98e": 72, "50e": [72, 148], "31462536": 72, "87e": [72, 98], "42e": 72, "31187300": 72, "31185626": 72, "21e": 72, "31185616": 72, "40125793": 72, "39816818": 72, "39816521": 72, "39816520": 72, "40309707": 72, "40288697": 72, "40288696": 72, "d_sigma": 72, "48604": 72, "v1": [72, 124, 125, 142, 144, 145, 153], "9595": 72, "83463": 72, "9638": 72, "96311": 72, "9573": 72, "9772": 72, "0541": [72, 156], "9765": 72, "0824": [72, 156], "0588": [72, 156], "9722": 72, "0749": [72, 156], "0136828971": 72, "76e": [72, 76], "14174508": 72, "39e": [72, 76], "14168623": 72, "14168468": 72, "14168467": 72, "18797246": 72, "66e": 72, "18637063": 72, "18637029": 72, "18637028": 72, "81e": 72, "26955011": 72, "26694944": 72, "26694790": 72, "85e": [72, 76], "32063129": 72, "53e": [72, 98], "31893708": 72, "31893873": 72, "31996133": 72, "31993255": 72, "85544": 72, "9645": 72, "07139": 72, "9634": 72, "26402": 72, "9652": [72, 156], "67876": 72, "9662": 72, "70581": 72, "9719": 72, "2366": 72, "0915": [72, 156], "9160": 72, "2533": [72, 156], "2254": [72, 156], "0964": [72, 156], "9756": 72, "0876": [72, 156], "9512": 72, "2365": 72, "0707": [72, 156], "8875": 72, "3356": 72, "2596": [72, 156], "0633": [72, 156], "nh2o": 72, "nlih": 72, "1587": 72, "20598": 72, "28257": 72, "33253": 72, "3528": 72, "42544": 72, "44361": 72, "14168": 72, "18637": 72, "26695": 72, "31894": 72, "31993": 72, "31186": 72, "39817": 72, "40289": 72, "lih_h2o_xyz": 72, "lih_h2o": 72, "basis_lih_h2o": 72, "scf_lih_h2o": 72, "85469422644599": 72, "adc1_results_lih_h2o": 72, "adc2_results_lih_h2o": 72, "33477": 72, "14169": 72, "event": 73, "planck": [73, 150], "annihil": [73, 97, 111, 141, 143], "lifetim": [73, 113, 130], "inspir": [73, 136, 143], "wiggli": 73, "lift": [73, 90], "knock": 73, "recombin": 73, "emit": [73, 91, 92, 144], "arrow": [73, 91, 120], "postul": 73, "perhap": [73, 100], "tip": 74, "unpolar": 74, "ellipt": [74, 89], "circularli": [74, 82], "ellips": 74, "statu": 74, "refract": [74, 76, 89, 91], "laboratori": [74, 76, 98, 100], "bot": 74, "beam": [74, 76, 82, 117], "exit": 74, "lin": 74, "kerr": [74, 76, 89], "electro": [74, 76, 98], "anisotrop": 74, "preferenti": 74, "emerg": 74, "anisotropi": [74, 89], "hyperpolariz": [74, 91, 150], "cotton": 74, "mouton": 74, "magneto": 74, "fluid": [74, 76, 82, 89], "perpendicularli": 74, "excess": [74, 122], "wavelength": [74, 82, 91, 124, 150], "rotatori": [74, 75, 90, 101, 124], "ord": 74, "faradai": [74, 150], "magnetochir": 74, "uparrow": 74, "antiparallel": 74, "a_2": 74, "reorgan": [74, 144], "reorient": 74, "dipolar": 74, "saw": 75, "irradi": [75, 111], "f_n": 75, "122760": 75, "708185001": 75, "793127822": 75, "799861180": 75, "800508543": 75, "800565380": 75, "800574227": 75, "800575131": 75, "800575290": 75, "800575329": 75, "800575338": 75, "800575340": 75, "12020540305318": 75, "98825": 75, "96801": 75, "97145": 75, "98065": 75, "00050": 75, "02821": 75, "01813": [75, 101], "02666": 75, "01218": 75, "00063": 75, "00222": 75, "8096766326331": 75, "98999": 75, "96500": 75, "97826": 75, "99416": 75, "99612": 75, "03529": 75, "00360": [75, 120], "00679": 75, "01598": 75, "00969": 75, "00250": 75, "00263": 75, "72755706157518": 75, "98934": 75, "97697": 75, "96858": 75, "99423": 75, "03496": 75, "99438": 75, "00381": 75, "00671": 75, "00220": 75, "01152": 75, "01394": 75, "00335": 75, "71682482474854": 75, "98622": 75, "95656": 75, "14202": 75, "98084": 75, "84833": 75, "04126": 75, "00283": 75, "01796": 75, "01163": 75, "00636": 75, "62861277592357": 75, "98447": 75, "95661": 75, "01098": 75, "98207": 75, "04117": 75, "97797": 75, "00370": 75, "01636": 75, "00441": 75, "00643": 75, "01380": 75, "00204": 75, "211386": [75, 90, 101, 106, 124, 125, 143, 144, 145, 148], "_get_active_mo": 75, "dipole_mo": 75, "icomp": 75, "dendriv": 75, "tden": 75, "get1den": 75, "dx": [75, 100], "tensordot": 75, "dy": 75, "450": 75, "01319": [75, 120], "685": [75, 156], "977": 75, "11535": 75, "377": [75, 156], "11499": 75, "dark": [75, 102], "interst": [75, 101, 124], "diposc": [75, 101, 124], "greather": [75, 101, 124], "44992": [75, 90, 101], "318937e": 75, "625297e": 75, "97654": [75, 90, 101], "153538e": 75, "749710e": 75, "37692": [75, 90, 101], "149882e": 75, "223962e": 75, "cg": [75, 90, 101, 124, 148], "exc": [75, 90, 100, 113], "gasscf": 75, "cumul": 75, "642674442": 75, "98387037576919": 75, "63914005847887": 75, "99997": 75, "00003": [75, 120], "56833156634588": 75, "54906255700261": 75, "99959": 75, "98314": 75, "02031": 75, "99696": 75, "97969": 75, "01686": 75, "00304": 75, "00041": [75, 81, 120], "47296765017848": 75, "99995": 75, "97129": 75, "02876": 75, "02871": 75, "97124": 75, "00005": [75, 99], "38059": [75, 90, 101], "468873e": 75, "091187e": 75, "83172": [75, 90, 101], "208787e": 75, "355741e": 75, "90237": [75, 90, 101], "045445e": 75, "623014e": 75, "729": 75, "708067912": 75, "739528252": 75, "740704223": 75, "740732582": 75, "740733616": 75, "740733655": 75, "740733657": 75, "11340211569278": 75, "98980": 75, "97263": 75, "97571": 75, "98356": 75, "00034": 75, "02409": 75, "00268": 75, "01544": [75, 124], "02279": 75, "01054": 75, "00046": 75, "00195": 75, "7351931372966": 75, "99830": 75, "99110": 75, "99600": 75, "99907": 75, "99382": 75, "01175": 75, "00118": 75, "00147": 75, "00444": 75, "00171": 75, "00035": 75, "00082": 75, "65407733183046": 75, "99450": 75, "99144": 75, "99900": 75, "01390": 75, "99166": 75, "00117": 75, "00153": 75, "00080": 75, "00149": 75, "00575": 75, "00047": 75, "64356171507335": 75, "99571": 75, "97554": 75, "12840": 75, "99582": 75, "86456": 75, "02646": 75, "00142": [75, 120], "00379": 75, "00507": 75, "00180": 75, "00051": 75, "00091": [75, 101], "55743398573296": 75, "99559": 75, "96489": 75, "02434": 75, "99775": 75, "03602": 75, "96813": 75, "00182": 75, "00191": 75, "00134": 75, "00164": 75, "00618": 75, "00039": 75, "29159": 75, "548866e": 75, "658376e": 75, "78501": 75, "247451e": 75, "355482e": 75, "12866": 75, "136810e": 75, "274229e": 75, "6329": 75, "787071882": 75, "791912542": 75, "792184181": 75, "792206026": 75, "792207797": 75, "792207936": 75, "792207948": 75, "792207950": 75, "11438963659845": 75, "98960": 75, "97168": 75, "97493": 75, "98327": 75, "02478": 75, "00289": 75, "01562": 75, "02338": 75, "01071": 75, "00060": 75, "00208": 75, "80003060665916": 75, "99159": 75, "97002": 75, "98187": 75, "99537": 75, "99592": 75, "03029": 75, "00318": 75, "00554": 75, "01330": 75, "00820": 75, "00236": 75, "00237": 75, "7189384955285": 75, "99111": 75, "97998": 75, "97319": 75, "03033": 75, "99427": 75, "00339": 75, "00552": 75, "00197": 75, "00953": 75, "01223": 75, "00311": 75, "70731804012333": 75, "98804": 75, "96044": 75, "12926": 75, "98430": 75, "86217": 75, "03726": 75, "01467": 75, "01016": 75, "00542": 75, "00348": 75, "00217": [75, 120, 143], "62036297238907": 75, "98665": 75, "95751": 75, "98540": 75, "04016": 75, "97604": 75, "00341": 75, "01331": 75, "00418": 75, "00547": 75, "01214": 75, "00187": 75, "55414": 75, "328951e": 75, "580239e": 75, "07698": 75, "154300e": 75, "705756e": 75, "44315": 75, "119484e": 75, "180816e": 75, "27763": 75, "793118310": 75, "798908867": 75, "799401560": 75, "799440899": 75, "799446125": 75, "799446623": 75, "799446711": 75, "799446734": 75, "799446738": 75, "799446739": 75, "12003281964508": 75, "98832": 75, "96820": 75, "97163": 75, "98078": 75, "00049": 75, "02805": 75, "00308": 75, "01801": [75, 120], "02650": 75, "01210": 75, "00062": 75, "00221": 75, "80828932732821": 75, "99041": 75, "96630": 75, "97922": 75, "99448": 75, "99598": 75, "03407": 75, "00351": 75, "00646": 75, "01523": 75, "00935": 75, "00243": 75, "00257": [75, 120], "72622990160039": 75, "98982": 75, "97785": [75, 124], "96971": 75, "99453": 75, "03391": 75, "99421": 75, "00372": 75, "00639": 75, "00215": 75, "01350": 75, "00324": 75, "7153774926884": 75, "98672": 75, "95763": 75, "14165": 75, "98172": 75, "84888": 75, "04031": 75, "00280": 75, "01710": 75, "01128": [75, 124, 151], "00608": 75, "00347": 75, "00235": 75, "62730415351615": 75, "98504": 75, "95735": 75, "01140": 75, "98291": 75, "04058": 75, "97774": 75, "00364": 75, "01556": 75, "00615": 75, "01336": 75, "00200": 75, "48297": 75, "323123e": 75, "607713e": 75, "01123": 75, "154562e": 75, "737591e": 75, "40783": 75, "150580e": 75, "218071e": 75, "38058973": 75, "30738694": 75, "83172339": 75, "90237127": 75, "monoton": 75, "unbal": 75, "accordin": 76, "omega_1": [76, 82, 83, 88, 91, 98, 117], "omega_2": [76, 82, 83, 88, 91, 98, 117], "omega_3": [76, 91], "eshg": 76, "eta": [76, 89, 91, 98], "thg": 76, "idri": 76, "rectif": [76, 98], "OR": [76, 98], "degener": [76, 91, 100, 122], "dfwm": 76, "perp": [76, 89, 98], "hyperpolarizabl": [76, 150], "signal": [76, 102, 142], "buffer": 76, "ultim": [76, 82], "analogi": 76, "zzz": [76, 83, 98], "zzzz": [76, 83], "3kt": [76, 89], "shg": [76, 98], "centrosymmetr": [76, 91], "molar": [76, 150], "n_a": [76, 150], "zxxz": 76, "xxz": 76, "10kt": 76, "avogadro": [76, 133, 150], "eop": [76, 98], "23538": 76, "statvolt": [76, 84, 91, 98], "esu": [76, 84, 91, 98], "omega_i": [76, 98], "cubicresponsedriv": [76, 83], "crf_drv": [76, 83], "a_oper": [76, 78, 83, 86, 88, 89, 98, 113], "b_oper": [76, 78, 83, 86, 88, 89, 98, 113], "c_oper": [76, 98], "d_oper": 76, "lrf": [76, 89, 98], "a_compon": [76, 78, 83, 86, 88, 89, 98, 113], "b_compon": [76, 78, 83, 86, 88, 89, 96, 98, 113], "c_compon": [76, 83, 98], "d_compon": [76, 83], "b_frequenc": [76, 83, 98], "0656": [76, 78, 88, 89, 98, 113, 156], "c_frequenc": [76, 83, 98], "d_frequenc": [76, 83], "004556": [76, 98], "crf_result": [76, 83], "556000e": [76, 98], "libxc": [76, 89, 98, 148], "lehtola": [76, 89, 98, 148], "steigemann": [76, 89, 98, 148], "oliveira": [76, 89, 98, 148], "marqu": [76, 89, 98, 148], "softwarex": [76, 89, 98, 148], "gerad": [76, 89, 98, 143, 148], "ungerad": [76, 89, 98, 143, 148], "28e": 76, "72e": 76, "46e": 76, "17e": 76, "crf": [76, 83], "998": [76, 101], "63439127": 76, "00000000j": [76, 89, 98], "1152": [76, 100, 156], "42872036": 76, "04492771j": 76, "w1": [76, 98], "w2": [76, 98], "w3": 76, "gamma_zzzz": 76, "6344": 76, "0000j": 76, "4287": 76, "0449j": 76, "conclud": [78, 143], "neon": [78, 141, 146, 157], "read_str": [78, 120, 153], "ne": [78, 143, 157], "lrf_drv": [78, 83, 88, 96], "result_str": 78, "lrf_result": [78, 83, 88, 89, 96], "lrf_length": 78, "lrf_veloc": 78, "837316": 78, "720512": 78, "362190": 78, "377629": 78, "augment": [78, 143, 144, 149], "mutual": [78, 82, 117], "multichromophor": 80, "chromophor": 80, "frenkel": [80, 94, 102, 105], "diabat": [80, 81], "monomer": 80, "le": [80, 81], "ct": [80, 81, 104, 105, 153], "l_b": 80, "l_bl_b": 80, "h_ah_a": 80, "h_al_b": 80, "ih_a": 80, "al_b": 80, "al_a": 80, "ih_b": 80, "h_bl_a": 80, "h_ah_b": 80, "l_bl_a": 80, "literatur": [80, 82], "c2h4": 81, "37731": 81, "01769": 81, "71611": 81, "04211": 81, "07142": 81, "72602": 81, "96225": 81, "74636": 81, "16458": 81, "90859": 81, "23094": 81, "24174": 81, "49049": 81, "84498": 81, "18262": 81, "54315": 81, "32947": 81, "25941": 81, "17537": 81, "48468": 81, "37427": 81, "06813": 81, "06658": 81, "62697": 81, "35657": 81, "40378": 81, "82687": 81, "92893": 81, "63558": 81, "29127": 81, "03527": 81, "90348": 81, "69157": 81, "24803": 81, "13578": 81, "15527": 81, "exmod_set": 81, "atoms_per_frag": 81, "ct_nocc": 81, "ct_nvir": 81, "method_set": [81, 100, 106, 113, 124, 131, 132, 142, 144, 148, 151, 153], "exmod_drv": 81, "excitonmodeldriv": 81, "monomer_natom": 81, "n_monom": 81, "monomer_start_indic": 81, "npair": 81, "total_le_st": 81, "total_ct_st": 81, "total_num_st": 81, "elec_trans_dipol": 81, "velo_trans_dipol": 81, "magn_trans_dipol": 81, "state_str": 81, "dimer_pair": 81, "inda": 81, "indb": 81, "excitation_id": 81, "get_excitation_id": 81, "monomers_info": 81, "get_sub_molecul": 81, "set_charg": [81, 120, 143, 144], "check_multipl": [81, 136], "monomer_scf": 81, "tda_result": [81, 115, 144], "monomer_tda": 81, "exc_energi": [81, 122], "exc_vector": 81, "one_elec_int": 81, "get_one_elec_integr": 81, "trans_dipol": 81, "get_le_trans_dipol": 81, "ind_a": 81, "monomer_a": 81, "ind_b": 81, "monomer_b": 81, "mo_a": 81, "mo_b": 81, "nocc_a": 81, "nocc_b": 81, "nvir_a": 81, "nvir_b": 81, "dimer_mo_coeffici": 81, "dimer_prop": 81, "dimer_properti": 81, "dimer_energi": 81, "exc_vectors_a": 81, "exc_vectors_b": 81, "dimer_excitation_vectors_le_a": 81, "dimer_excitation_vectors_le_b": 81, "dimer_excitation_vectors_ct_ab": 81, "dimer_excitation_vectors_ct_ba": 81, "c_vec": 81, "frag": 81, "sigma_vector": 81, "dimer_sigma_vector": 81, "get_ct_trans_dipol": 81, "i_vec": 81, "s_vec": 81, "30897": 81, "341337": 81, "344649": 81, "355572": 81, "375562": 81, "008184": 81, "000293": 81, "001344": 81, "000181": 81, "000038": 81, "000421": 81, "000136": 81, "000216": 81, "000076": 81, "000301": 81, "000065": 81, "000215": 81, "000057": 81, "001349": 81, "000075": 81, "000053": 81, "000226": 81, "014982": 81, "021419": 81, "00015": [81, 120], "00193": 81, "000318": 81, "002297": 81, "000302": 81, "002587": 81, "001974": 81, "309078": 81, "341401": 81, "344651": 81, "355577": 81, "375687": 81, "014984": 81, "000972": 81, "000351": 81, "001949": 81, "000333": 81, "002323": 81, "002045": 81, "002715": 81, "405391": 81, "000285": 81, "405247": 81, "5d": [81, 120], "eigvec": 81, "rotatory_strength": [81, 102, 105, 113], "dip_strength": 81, "87296": 81, "61775": 81, "1571": [81, 156], "28395": 81, "29395": 81, "0139": [81, 125, 153, 156], "37382": 81, "0007": [81, 156], "0213": [81, 156], "38091": 81, "0018": [81, 156], "s7": 81, "67239": 81, "0004": [81, 105, 156], "s8": 81, "67370": 81, "0028": [81, 156], "s9": 81, "20674": 81, "0108": [81, 125, 156], "s10": 81, "22814": 81, "0016": [81, 156], "0072": [81, 156], "s11": 81, "03968": 81, "0243": [81, 156], "0013": [81, 156], "s12": 81, "36147": 81, "0053": [81, 156], "0163": [81, 125, 156], "c_squar": 81, "xmin": [81, 106, 124, 125, 131, 142, 143, 144, 148, 151, 156], "xmax": [81, 106, 124, 125, 131, 142, 143, 144, 148, 151, 156], "xstep": [81, 106, 124, 125, 143, 144, 148, 151], "yi": [81, 106, 113, 124, 125, 142, 143, 144, 148, 151], "211385": 81, "y_ab": 81, "y_ecd": 81, "x_ref": 81, "29347889": 81, "31661749": 81, "33498928": 81, "33948716": 81, "34142481": 81, "34378921": 81, "35317567": 81, "35467501": 81, "37317654": 81, "37523192": 81, "38737236": 81, "38809457": 81, "40824740": 81, "41131899": 81, "44405319": 81, "44836638": 81, "45442440": 81, "45618961": 81, "45869117": 81, "46343516": 81, "46961985": 81, "47008569": 81, "48617428": 81, "48913889": 81, "49490201": 81, "49583015": 81, "49623637": 81, "50093006": 81, "50196948": 81, "50276614": 81, "54606024": 81, "54653988": 81, "54825489": 81, "54984647": 81, "55276288": 81, "55355450": 81, "56052689": 81, "56204114": 81, "56307883": 81, "56521540": 81, "57830505": 81, "57987938": 81, "58276149": 81, "59040369": 81, "59608911": 81, "59657872": 81, "60755394": 81, "61502897": 81, "62056515": 81, "62125169": 81, "y_abs_ref": 81, "0293": [81, 156], "1700": [81, 156], "0189": [81, 153, 156], "0008": [81, 156], "0003": [81, 156], "0036": [81, 156], "0011": [81, 156], "0076": [81, 156], "0042": [81, 156], "0170": [81, 156], "0268": [81, 156], "0055": [81, 156], "2073": 81, "7341": 81, "7807": 81, "8590": 81, "0543": [81, 156], "0794": [81, 156], "0043": [81, 156], "1701": 81, "0002": [81, 156], "0190": [81, 156], "4825": 81, "0609": [81, 156], "0031": [81, 156], "2050": [81, 156], "0191": [81, 153, 156], "0152": [81, 125, 153, 156], "y_ecd_ref": 81, "144750": 81, "164027": 81, "000035": 81, "014472": 81, "001995": 81, "004958": 81, "000899": 81, "019302": 81, "000786": 81, "013440": 81, "007686": 81, "000918": 81, "001135": 81, "000019": 81, "000222": 81, "003878": 81, "000392": 81, "000790": 81, "006479": 81, "047084": 81, "458896": 81, "154583": 81, "063050": 81, "217650": 81, "459211": 81, "383874": 81, "041366": 81, "032507": 81, "000123": 81, "000373": 81, "025144": 81, "050821": 81, "000443": 81, "003195": 81, "001069": 81, "000036": 81, "285024": 81, "269169": 81, "004591": 81, "000050": 81, "005488": 81, "001347": 81, "000665": 81, "000083": 81, "023592": 81, "011323": 81, "x0_ref": 81, "y0_ref": 81, "x1_ref": 81, "y1_ref": 81, "euler": 82, "cosin": 82, "einstein": [82, 88, 91], "lambda_1": [82, 94, 117], "lambda_n": 82, "rotation": 82, "e_z": 82, "lambda_2": [82, 94, 117], "control": [82, 128, 142], "solenoid": 82, "monochromat": [82, 99, 111, 117, 129], "lp": 82, "137": [82, 98, 124, 125, 142, 144, 150, 156], "cp": 82, "instant": 82, "helix": 82, "clockwis": 82, "bed": 82, "mj": 82, "puls": [82, 144], "durat": 82, "mathsf": 82, "gw": [82, 111], "damag": [82, 144], "nonvanish": [82, 91], "subtract": [82, 113], "sum_l": 82, "sum_m": 82, "multipolar": 82, "tensori": 82, "ex": [82, 91], "sake": 82, "symplic": 82, "quadrupol": [82, 91, 102, 150], "popolar": 82, "traceless": [82, 84], "concentr": 82, "imping": [82, 91], "rigidli": 82, "loss": 82, "e_x": [82, 144], "enclos": 82, "parenthes": 82, "swap": 82, "i_3": 82, "wagni\u00e8r": 82, "av": 82, "reintroduc": [82, 144], "gather": [82, 96], "pseudoscalar": 82, "rigor": 82, "detector": 82, "transvers": 82, "albeit": [82, 122, 142, 144, 149], "ecd": 82, "lk": 82, "reassoci": 82, "front": [82, 94], "conterpart": 82, "assembli": [82, 142], "absorb": [82, 91, 117, 130, 142, 144], "uniform": [83, 96], "slower": 83, "polarizabilti": 83, "qrf_drv": [83, 98], "quadraticresponsedriv": [83, 98], "numerical_deriv": 83, "d2": 83, "hyperpolarizaibl": 83, "qrf_result": [83, 98], "qrf": [83, 98], "dmu": 83, "dalpha": 83, "dbeta": 83, "nnumer": 83, "744762": 83, "34779": 83, "73492": 83, "744763": 83, "71224": 83, "1047": [83, 156], "34781": 83, "73532": 83, "73499": 83, "151": 83, "theta_": [84, 91], "2n": [84, 91, 113, 136], "tabul": 84, "octupol": 84, "hexadecapol": 84, "unambigu": 84, "bf": 84, "obvious": 84, "z_": [84, 88, 94, 96], "fold": [84, 100], "ge": 84, "47835": 84, "5417": [84, 91], "48655": 84, "3450": [84, 91], "stavolt": 84, "invit": 86, "z_n": 86, "kappa_n": 86, "g_m": 86, "dagger_j": 86, "dagger_a": [86, 90], "0_j": 86, "0_i": [86, 113], "0_": 86, "ethylene_xyz": [88, 96], "67759997": [88, 94, 96, 102, 105, 113, 115], "21655197": [88, 94, 96, 102, 105, 113, 115], "92414474": [88, 94, 96, 102, 105, 113, 115], "mu_x_ao": 88, "get_full_vector": [86, 88, 96], "23248623e": [], "91519961e": [], "69416713e": [], "64234609e": [], "89579507e": [], "06669079e": [], "28920938e": [], "28266220e": [], "44677557e": [], "11076999e": [], "domain": 88, "sinusoid": 88, "omega_0": 88, "2i": [88, 100], "cetera": 88, "omega_x": 88, "f_x": [88, 96], "thought": [88, 97, 99], "normalz": 88, "whatev": 88, "recognit": 88, "minu": [88, 99, 111, 113, 143], "vector_to_matrix": 88, "zymat": 88, "expectation_valu": 88, "alpha_xx": [88, 113], "84380178": 88, "interpret": [89, 142, 150], "darwin": 89, "iso": 89, "macroscop": [89, 91, 98], "permitt": [89, 91, 150], "permeabl": [89, 150], "electrodynam": 89, "ill": [89, 111, 144], "slowli": [89, 108], "nondipolar": 89, "quantit": [89, 153], "birefring": 89, "hyper": 89, "2k": 89, "01161246": 89, "19770107": 89, "20248108": 89, "18863810": 89, "53971511": 89, "31867382": 89, "64430453": 89, "31469367": 89, "46320379": 89, "84501162": 89, "57203409": 89, "83255985": 89, "09615293": 89, "02138969": 89, "29211162": 89, "02009095": 89, "73585054": 89, "04219749": 89, "84454457": 89, "04171911": 89, "31931552": 89, "11162972": 89, "45876238": 89, "11004217": 89, "09692448": 89, "00083876": 89, "29287459": 89, "00078245": 89, "73799055": 89, "00264362": 89, "84673034": 89, "00268306": 89, "34755032": 89, "01367302": 89, "48835616": 89, "01341692": 89, "56e": 89, "09692566": 89, "00005136": 89, "29287577": 89, "00005883": 89, "73800472": 89, "00017941": 89, "84674589": 89, "00018212": 89, "34779283": 89, "00065565": 89, "48860561": 89, "00064486": 89, "73800476": 89, "00000564": 89, "84674594": 89, "00000865": 89, "34779352": 89, "00003494": 89, "48860634": 89, "00003797": 89, "comp": 89, "096926": 89, "yx": [89, 142], "zx": 89, "292876": 89, "738005": 89, "zy": 89, "846746": 89, "347794": 89, "488606": 89, "complexrespons": [89, 113], "00454": [89, 120], "46269350": 89, "84498224": 89, "57145838": 89, "01536178j": 89, "83253311": 89, "31865693": 89, "11164275": 89, "45878685": 89, "01990331j": 89, "10876894": 89, "34689234": 89, "01367735": 89, "48759482": 89, "01998091j": 89, "01336083": 89, "48e": 89, "34713524": 89, "00054764": 89, "48784349": 89, "01998114j": 89, "00053700": 89, "34713579": 89, "00002708": 89, "48784407": 89, "00003524": 89, "347136": 89, "000000j": [89, 98], "487844": 89, "019981j": 89, "altogeth": 90, "unocc": [90, 94, 111], "0n": [90, 117], "o_2p": [90, 101, 124], "991312026": 90, "006166338": 90, "032227092": 90, "034907536": 90, "037509034": 90, "037708221": 90, "037802925": 90, "037839963": 90, "037842633": 90, "037843292": 90, "037843330": 90, "037843340": 90, "037843341": [90, 101], "0378433408259": 90, "99931": [90, 101], "97806": [90, 101], "97495": [90, 101], "02400": [90, 101], "02368": [90, 101], "55485": [90, 101], "07299": 90, "50217": 90, "83591": 90, "975": [90, 101, 124], "70221": 90, "75289": 90, "73042": 90, "68038": 90, "78478": 90, "981834": 90, "495574": 90, "mcrpa": [90, 124], "mclr_eigensolv": [90, 124], "rsp_dict": [90, 153], "mc": [90, 124], "647019008": 90, "513232268": 90, "473594122": 90, "458084076": 90, "453452539": 90, "452548808": 90, "452313010": 90, "452201613": 90, "452196083": 90, "452191087": 90, "452190945": 90, "452190916": 90, "452190914": 90, "3310434": 90, "00815": 90, "0389358": 90, "0122841": 90, "4090433": 90, "13064": 90, "0000000": [90, 124], "4311622": 90, "73252": 90, "1736409": 90, "1284413": 90, "5113197": 90, "91372": 90, "1444330": 90, "1449627": 90, "5783860": 90, "73868": 90, "3471652": 90, "4072428": 90, "fci_excitation_energi": [90, 101], "68451": [90, 101], "cis_excitation_energi": [90, 101], "30739": [90, 101], "casci_excitation_energi": 90, "61974291": 90, "73087038": 90, "61579239": 90, "51654574": 90, "sa_casscf_excitation_energi": 90, "55787583": 90, "83566209": 90, "32868402": 90, "56323891": 90, "mcrpa_6_5_excitation_energi": 90, "00814853": 90, "1306361": 90, "73252108": 90, "91371718": 90, "get_excitation_charact": 90, "33104335562552106": 90, "391": 90, "574": 90, "616": 90, "384": 90, "40904333562087525": 90, "664": 90, "700": 90, "4311622010138693": 90, "207": [90, 150, 156], "332": 90, "335": 90, "665": 90, "5113196797605539": 90, "215": 90, "106": [90, 156], "386": 90, "415": [90, 136], "585": 90, "5783859960264529": 90, "519": [90, 144], "459": 90, "broadli": [90, 103], "sizeabl": 90, "perfectli": 90, "037271082": 90, "037273353": 90, "037273800": 90, "037273988": 90, "037274022": 90, "037274031": [90, 124], "037274032": [90, 124], "03727403201918": 90, "97794": [90, 124], "97490": [90, 124], "02386": [90, 124], "02330": [90, 124], "55475": 90, "07554": 90, "50212": [90, 124], "83330": 90, "70218": 90, "75294": 90, "73232": 90, "67760": 90, "78416": 90, "16377": [90, 124], "983159": 90, "498941": 90, "710067027": 90, "504433348": 90, "460454267": 90, "438804358": 90, "436938061": 90, "423456314": 90, "421352332": 90, "420272535": 90, "420217560": 90, "420204856": 90, "420204685": 90, "420204669": 90, "3305288": 90, "99415": 90, "0389580": 90, "0121777": [90, 124], "4084609": 90, "11479": 90, "4307468": 90, "72122": 90, "1738542": 90, "1284536": 90, "5110821": 90, "90725": 90, "1450310": 90, "1453630": 90, "mcrpa_4_4_excitation_energi": 90, "99414655": 90, "11478813": 90, "7212186": 90, "90725253": 90, "3305287922814632": 90, "4084609334794776": 90, "670": 90, "43074684235636357": 90, "281": 90, "205": 90, "5110821086027035": 90, "221": [90, 124, 143, 144], "216": 90, "388": 90, "583": 90, "invok": 90, "modest": 90, "damcoff": 90, "710192193": 90, "505688090": 90, "467941118": 90, "447283455": 90, "445599132": 90, "434442055": 90, "432814242": 90, "431128477": 90, "430925260": 90, "430911781": 90, "430909612": 90, "430909517": 90, "430909448": 90, "430909446": 90, "3459460": 90, "41367": 90, "0403367": 90, "0142157": 90, "4209258": 90, "45397": 90, "4376907": 90, "91017": 90, "1841986": 90, "1222064": 90, "5190753": 90, "12476": 90, "1187446": 90, "1440273": 90, "mctda_4_4_excitation_energi": 90, "41366984": 90, "45397333": 90, "9101715": 90, "12475838": 90, "vacuo": 91, "axial": 91, "nabla_": 91, "xi_": 91, "eta_": 91, "hypermagnetiz": 91, "classif": 91, "tie": 91, "prime_": 91, "prime": [91, 100], "incom": [91, 98, 129, 142, 144], "outgo": [91, 129, 144], "ward": 91, "r_i": 91, "omega_j": 91, "outcom": 91, "diamagnet": 91, "suscept": 91, "dia": 91, "2m_i": 91, "p_i": 91, "birss": 91, "cite": 91, "birr": 91, "characterist": [91, 150], "examin": [91, 122], "summar": [91, 125], "paragraph": 91, "po": 91, "ae": 91, "appar": [91, 143], "thumb": 91, "prescript": 91, "therein": [91, 136], "cf": [91, 133, 144], "6mm": 91, "mmm": 91, "m3m": 91, "simplif": 91, "bulk": 91, "104206": 91, "vm": 91, "7153": 91, "478353": 91, "486551": 91, "648777": 91, "4818": 91, "206362": 91, "6392": [91, 98], "235381": 91, "formaldehyd": [92, 143], "chemi": 92, "bio": 92, "luminesc": 92, "moieti": 92, "snapshot": [92, 157], "dioxetane_xyz": 92, "competit": 92, "formaldehyde_str": 92, "08516846": 92, "12131123": 92, "93777476": 92, "71598634": 92, "settl": 92, "messag": 92, "td": [92, 122], "troubl": [92, 101], "photochemistri": 93, "repsect": 94, "t_f": 94, "z_f": 94, "y_f": 94, "integrand": 94, "singular": [94, 143], "svd": 94, "bright": [94, 102], "s_2": 94, "lreig_drv": [94, 102, 105], "linearresponseeigensolv": [86, 94, 102, 105, 106, 113, 115, 124, 144, 148, 151, 153], "nto_cub": [94, 153], "lreig_result": [94, 102, 105], "nto_lambda": 94, "72499013e": 94, "72475474e": 94, "29239846e": 94, "29211293e": 94, "24552557e": 94, "24323138e": 94, "88180541e": 94, "88178172e": 94, "99380768e": 94, "99361419e": 94, "04378289e": 94, "04255915e": 94, "28944812e": 94, "28167411e": 94, "18819618e": 94, "17971235e": 94, "nto_h5_fil": [94, 153], "576": 94, "xf": [94, 106, 113, 148], "eigenvectors_distribut": [94, 113], "zf": 94, "yf": 94, "exponenti": [96, 97], "shall": 96, "lr": 96, "mobil": 96, "redistribut": 96, "0_x": 96, "s_field": 96, "c_field": 96, "pylab": 96, "_1e": 97, "_2e": 97, "_ne": 97, "_pe": 97, "rp": 97, "overbar": 97, "k31": 97, "k32": 97, "k41": 97, "k42": 97, "5j": 97, "k13": 97, "k23": 97, "k14": 97, "k24": 97, "1j": [86, 97, 99], "20240208": 97, "414314": 97, "272098": 97, "000049j": 97, "063249": 97, "357053j": 97, "609038": 97, "501889j": 97, "784682": 97, "400653": 97, "136519j": 97, "138307": 97, "334586j": 97, "78434": 97, "265899": 97, "058835j": 97, "414656": 97, "25j": 97, "707107": 97, "psi_3": 97, "psi_4": 97, "k51": 97, "k61": 97, "k52": 97, "k62": 97, "k15": 97, "k16": 97, "k25": 97, "k26": 97, "195145": 97, "674738": 97, "007566j": 97, "272185": 97, "364692j": 97, "150157": 97, "219078j": 97, "077445": 97, "261337j": 97, "390656": 97, "045347j": 97, "pockel": 98, "kleinman": 98, "satur": 98, "pluta": 98, "proven": 98, "face": 98, "20636": 98, "1312": [98, 156], "44e": 98, "16e": 98, "165": 98, "73136841": 98, "98788527": 98, "24601088j": 98, "04348163": 98, "22700923j": 98, "beta_zzz": 98, "731368": 98, "987885": 98, "246011j": 98, "043482": 98, "227009j": 98, "weaker": [99, 111, 120, 143, 144], "encompass": [99, 111], "vast": [99, 111], "overwhelm": [99, 111], "erf": [99, 111], "schr\u00f6inger": 99, "evolut": [99, 111], "fw": 99, "eb": 99, "muab": 99, "muba": 99, "neglig": [99, 100, 143, 144], "alpha_numer": 99, "eba": 99, "alpha_analyt": 99, "wb": 99, "alpha_wa": 99, "alpha_wb": 99, "vline": 99, "headwidth": 99, "headlength": 99, "diatom": [100, 103, 143], "dfrac": 100, "m_b": 100, "speric": 100, "y_j": 100, "e_j": 100, "2j": 100, "branch": 100, "equidist": 100, "x_a": 100, "x_b": 100, "pick": 100, "forbidden": [100, 102, 141], "accept": 100, "renew": 100, "hcl": 100, "cl": [100, 131], "scf_set": [100, 106, 124, 131, 142, 144, 148, 151, 153], "11p": 100, "num_drv": 100, "numerovdriv": 100, "pec_displac": 100, "pec": 100, "pec_potenti": 100, "el_transit": 100, "boolean": 100, "final_el_st": 100, "exc_conv_thresh": 100, "n_vib_stat": 100, "temp": 100, "kelvin": [100, 150], "n_rot_stat": 100, "n_margin": 100, "p_margin": 100, "steps_per_au": 100, "numerov_set": 100, "num_result": 100, "convergec": 100, "ang": 100, "85540": 100, "2211": [100, 156], "16191": 100, "3269": 100, "13406": 100, "5386": 100, "42849": 100, "6444": 100, "80534": [100, 101], "7503": 100, "21628": 100, "174": 100, "166": 100, "2615": [100, 156], "94747e": 100, "44302e": 100, "2576": 100, "73425e": 100, "2556": 100, "04621e": 100, "2536": [100, 156], "83968e": 100, "2517": 100, "56958e": 100, "2497": [100, 156], "52708e": 100, "2478": 100, "10791e": 100, "2458": [100, 156], "86134e": 100, "2635": 100, "86084e": 100, "2654": 100, "37859e": 100, "2674": 100, "76177e": 100, "2694": 100, "18696e": 100, "2713": 100, "46448e": 100, "2733": 100, "80881e": 100, "2752": 100, "65905e": 100, "2772": 100, "44870e": 100, "2792": 100, "45524e": 100, "2811": 100, "72649e": 100, "2831": 100, "67969e": 100, "vib_level": 100, "vib_psi2": 100, "vib_energi": 100, "psi2": 100, "fi": 100, "rigid": [100, 149], "rotor": 100, "frank": 100, "herzberg": 100, "teller": 100, "exict": 100, "00371": 100, "18856": 100, "77836": 100, "68682": 100, "83574": 100, "11225": 100, "28673": 100, "139": [100, 156], "78431": 100, "62970e": 100, "80560": 100, "18422e": 100, "82592": 100, "98800e": 100, "75795": 100, "01134e": 100, "73268": 100, "47555e": 100, "i_potenti": 100, "i_psi": 100, "i_vib_level": 100, "f_potenti": 100, "f_psi": 100, "f_vib_level": 100, "de_elec": 100, "pec_energi": 100, "gs_potenti": 100, "gs_vib_psi2": 100, "gs_vib_energi": 100, "es_potenti": 100, "es_vib_psi2": 100, "es_vib_energi": 100, "gs_energi": 100, "es_energi": 100, "read_pec_data": 100, "bond_length": 100, "tmom": 100, "trans_moment": 100, "set_reduced_mass": 100, "194": [100, 156], "193": [100, 136], "191": 100, "187": [100, 144], "195": 100, "173": 100, "171": 100, "43314": 100, "67445e": 100, "46035": 100, "61293e": 100, "48755": 100, "10780e": 100, "51475": 100, "17810e": 100, "54195": 100, "08405e": 100, "56916": 100, "34778e": 100, "59636": 100, "89534e": 100, "62356": 100, "04635e": 100, "65076": 100, "20261e": 100, "67796": 100, "94669e": 100, "39983": 100, "56212e": 100, "36651": 100, "98373e": 100, "33320": 100, "60179e": 100, "29988": 100, "18635e": 100, "26656": 100, "19878e": 100, "23325": 100, "02682e": 100, "19993": 100, "61992e": 100, "16662": 100, "95672e": 100, "13330": 100, "83167e": 100, "gs_psi2": 100, "es_psi2": 100, "ll": 101, "62002504": 101, "73138794": 101, "61624803": 101, "51670672": 101, "imbal": 101, "n_th": 101, "e1": 101, "03784334097188": 101, "07301": 101, "50216": 101, "83590": 101, "70220": 101, "75290": 101, "73044": 101, "68036": 101, "78476": 101, "981835": 101, "495575": 101, "353559469": 101, "593571375": 101, "632461251": 101, "642345169": 101, "642439232": 101, "642461616": 101, "642463966": 101, "642464740": 101, "642464800": 101, "642464810": 101, "642464811": 101, "99867538836281": 101, "98064": 101, "98062": 101, "01721": 101, "99899": 101, "02255": 101, "6424648114672": 101, "99396": 101, "97991": 101, "02521": 101, "71709": 101, "18832": 101, "84981": 101, "980": 101, "98576": 101, "12396": 101, "35135": 101, "52545": 101, "73663": 101, "99710": 101, "878313": 101, "232449": 101, "001754": 101, "004459": 101, "2nd": [101, 150], "7588": 101, "6845": 101, "hinder": 101, "broader": 101, "gap": [101, 113, 122, 124, 126], "349459644": 101, "357346944": 101, "498295478": 101, "612871787": 101, "623966139": 101, "624835693": 101, "612659551": 101, "621464196": 101, "624429113": 101, "629064929": 101, "630931527": 101, "631869670": 101, "634998565": 101, "474779653": 101, "559709493": 101, "636134037": 101, "632576587": 101, "628217000": 101, "634720590": 101, "637351866": 101, "624461265": 101, "631750868": 101, "632562481": 101, "636046647": 101, "636930293": 101, "637342129": 101, "631279519": 101, "635720026": 101, "636480515": 101, "636878803": 101, "637497423": 101, "637695019": 101, "637847521": 101, "626206234": 101, "629362438": 101, "634231718": 101, "636493139": 101, "637385781": 101, "636852565": 101, "637628176": 101, "637786548": 101, "637881310": 101, "633537870": 101, "636485156": 101, "637558801": 101, "637513189": 101, "637729900": 101, "637880391": 101, "637887967": 101, "637945853": 101, "99248196219575": 101, "99882": 101, "98031": 101, "97980": 101, "01802": 101, "02306": 101, "64016061987452": 101, "99577": 101, "97809": 101, "02452": 101, "00161": 101, "63794585280809": 101, "98067": 101, "99160": [101, 124], "99806": 101, "02967": 101, "72399": 101, "21935": 101, "35489": 101, "95695": 101, "85270": 101, "12384": 101, "030": [101, 113], "25400": 101, "98349": 101, "00141": 101, "027719": 101, "070456": 101, "821550": 101, "088171": 101, "822017": 101, "089359": 101, "020799": 101, "052865": 101, "037923": 101, "096390": 101, "043252": 101, "109936": 101, "057847": 101, "147033": 101, "011887": 101, "030215": 101, "059056": 101, "150106": 101, "cumbersom": [101, 142], "betweem": 101, "compromis": [101, 124], "55787634": 101, "83565758": 101, "32867792": 101, "56323052": 101, "deterior": [101, 144], "first_exc_energi": 101, "843270570": 101, "858829181": 101, "864455914": 101, "864858793": 101, "864894174": 101, "864897105": 101, "864897238": 101, "864897243": 101, "01351106935542": 101, "98571": 101, "97737": 101, "99925": 101, "01512": 101, "02254": 101, "71628341721825": 101, "99623": 101, "97627": 101, "00146": 101, "02604": 101, "64857": 101, "19270": 101, "985": 101, "86834": 101, "973": 101, "76522": 101, "43591": 101, "515": [101, 113, 144], "12362": 101, "60891": 101, "84500": 101, "10548": 101, "914415": 101, "324211": 101, "066692": 101, "169513": 101, "08798": 101, "153103e": 101, "791691e": 101, "724068655": 101, "725200119": 101, "725331151": 101, "725334435": 101, "725334997": 101, "725335073": 101, "725335090": 101, "00986341043273": 101, "98623": 101, "97762": 101, "01412": 101, "02272": 101, "71760513688903": 101, "99620": 101, "97731": 101, "00100": 101, "02548": 101, "4485367237144": 101, "99442": 101, "99771": 101, "00266": 101, "00751": 101, "66135": 101, "25118": 101, "988": 101, "84539": 101, "666": [101, 124, 151], "50141": 101, "648": [101, 125], "70435": 101, "675": 101, "08480": 101, "55591": 101, "84550": 101, "08882": 101, "902880": 101, "294892": 101, "071924": 101, "182813": 101, "220125": 101, "559501": 101, "95275": 101, "899035e": 101, "003629e": 101, "27448": 101, "502994e": 101, "169096e": 101, "650642982": 101, "692220117": 101, "694350449": 101, "694439713": 101, "694445644": 101, "694446718": 101, "694446789": 101, "694446804": 101, "99698121055799": 101, "98702": 101, "98210": 101, "99942": 101, "01415": 101, "01731": 101, "70831745311033": 101, "99704": 101, "98460": 101, "00024": [101, 120], "62405336905468": 101, "98743": 101, "99379": 101, "02056": 101, "99822": 101, "44843518488997": 101, "99702": 101, "00111": 101, "99835": 101, "99825": 101, "00526": 101, "67802": 101, "24525": 101, "87394": 101, "734": 101, "74018": 101, "499": 101, "46605": 101, "512": [101, 144], "10271": 101, "267": [101, 156], "23802": 101, "99722": 101, "08042": 101, "865079": 101, "198812": 101, "085985": 101, "218553": 101, "042742": 101, "108641": 101, "237138": 101, "602745": 101, "85494": 101, "812051e": 101, "149862e": 101, "92670": 101, "583994e": 101, "096522e": 101, "630250704": 101, "672532115": 101, "683260739": 101, "686039130": 101, "686051087": 101, "686051424": 101, "686051445": 101, "98214396906145": 101, "98461": 101, "99145": 101, "99958": 101, "01560": 101, "00875": 101, "70439717084962": 101, "98783": 101, "01582": 101, "99913": 101, "62069022907059": 101, "99499": 101, "99411": 101, "99764": 101, "01326": 101, "60257216026255": 101, "96066": 101, "22366": 101, "99968": 101, "04213": 101, "77386": 101, "52045369603377": 101, "97487": 101, "01895": 101, "99956": 101, "97610": 101, "03052": 101, "68941": 101, "44678": 101, "976": 101, "604": [101, 144, 156], "58138": 101, "50270": 101, "414": 101, "21172": 101, "406": 101, "11950": 101, "00726": 101, "07263": 101, "847570": 101, "154309": 101, "071706": 101, "182257": 101, "023140": 101, "058815": 101, "110856": 101, "281768": 101, "135447": 101, "344272": 101, "55788": 101, "182600e": 101, "629917e": 101, "32868": 101, "101141e": 101, "302122e": 101, "56323": 101, "491871e": 101, "439096e": 101, "deteriot": 101, "degrad": 101, "undesir": 101, "modulu": 102, "2h": 102, "frontier": [102, 148], "slight": 102, "supramolecular": 102, "pi_1": 102, "pi_2": 102, "capit": 102, "1b_": 102, "electric_transition_dipol": [102, 105, 113, 124, 151], "magnetic_transition_dipol": [102, 105, 113], "2114": [102, 105, 106, 113, 115, 144, 148, 156], "5915": [102, 105], "9272": 102, "2471": [102, 105, 156], "6703": 102, "5637": 102, "4311": [102, 105], "9185": 102, "1743": 102, "7460": [102, 105, 143], "4909": 102, "band": 102, "acquir": 102, "bisign": 102, "microwav": 103, "thorough": 104, "zcoord": 105, "underestim": [105, 128, 143], "3348": 105, "6384": 105, "7892": 105, "8796": 105, "1239": 105, "1364": 105, "1403": [105, 156], "1582": [105, 156], "1462": [105, 156], "1434": [105, 156], "1424": [105, 156], "1910": [105, 156], "1955": [105, 156], "2069": 105, "2095": 105, "2104": [105, 156], "3491": 105, "2266": [105, 156], "2157": [105, 156], "2123": 105, "8032": [105, 156], "1899": 105, "3113": 105, "3716": 105, "4077": 105, "6507": 105, "cell": [105, 147], "detach_attach": [105, 153], "dimer_20a": 105, "9598": 105, "0065": [105, 156], "8031": 105, "5360": 105, "0214": [105, 125, 156], "exc_str": 105, "excitation_detail": [105, 113], "orb_str": 105, "5030": 105, "4914": 105, "6399": 105, "2917": 105, "5896": 105, "5668": [105, 156], "4108": 105, "3954": 105, "5959": 105, "5734": 105, "4015": 105, "3858": 105, "8128": 105, "5566": 105, "8125": 105, "5570": 105, "valet": [105, 113, 153], "subgroup": [105, 153], "ampli": 105, "transition_analysis_util": [105, 113, 153], "subgroup_nam": [105, 153], "atom_subgroup_map": [105, 153], "plot_transition_diagram": [105, 153], "state_index": [105, 153], "density_type_plu": [105, 153], "density_type_minu": [105, 153], "hole_cub": [105, 153], "particle_cub": [105, 153], "load_transit": [105, 153], "segment_arrai": [105, 153], "compute_atomic_charg": [105, 153], "subgroup_info": [105, 153], "subgroupinfo": [105, 153], "set_subgroup": [105, 153], "compute_subgroup_charg": [105, 153], "diagram_titl": [105, 153], "create_diagram": [105, 153], "save_plot": [105, 153], "allevi": 106, "vlx_mol": [106, 148], "vlx_ba": [106, 148], "lr_eig_solv": [106, 148], "lr_solver": [106, 148], "e2": [86, 106, 113, 115, 148], "get_e2": [86, 106, 113, 115, 148], "v1_x": [106, 148], "v1_y": [106, 148], "v1_z": [106, 148], "get_prop_grad": [86, 106, 113, 148], "sinv": [106, 148], "clariti": [106, 148], "fosc": [106, 113, 148], "tm": [106, 113, 124, 148, 149, 151], "res_mo": 106, "res_indx": 106, "deexcit": 106, "c_int_deex": 106, "e2_cv": 106, "s2_cv": 106, "v1_cvs_x": 106, "v1_cvs_y": 106, "v1_cvs_z": 106, "eigs_cv": 106, "x_cv": 106, "fosc_cv": 106, "xf_cv": 106, "tm_cv": 106, "core_excit": [106, 144, 148], "num_core_orbit": [106, 144, 148], "o1": [106, 142], "vlx_cvs_result": [106, 148], "525": [106, 144, 148], "x10": [106, 148], "siplifi": 108, "futil": 108, "seldom": 109, "tractabl": 109, "met": 111, "seek": 111, "secondari": 111, "ehrenfest": 111, "histor": 113, "ethene_xyz": [113, 115, 131, 133], "from_xyz_str": [113, 115, 153], "nmo": 113, "nhomo": 113, "2318428": 113, "23036306": 113, "03031426": 113, "79297209": 113, "64755459": 113, "57527959": 113, "51027799": 113, "3664635": 113, "17010963": 113, "26253257": 113, "29520837": 113, "31109777": 113, "38857996": 113, "47929591": 113, "68491581": 113, "78814557": 113, "78870971": 113, "8870793": 113, "89030532": 113, "97978752": 113, "15705815": 113, "20987525": 113, "2392286": 113, "2517033": 113, "36026403": 113, "54571226": 113, "lres_drv": [86, 113, 115], "rsp_set": 113, "lres_out": 113, "velocity_transition_dipol": 113, "print_tabl": 113, "lre": 113, "933": 113, "45586": 113, "53151": 113, "00012": 113, "02174": 113, "461": 113, "629": 113, "858": 113, "538": [113, 144, 145], "589": 113, "919": 113, "72579": 113, "40916": 113, "11817": 113, "74133": 113, "5pt": 113, "20pt": 113, "10pt": 113, "25pt": 113, "dim": [86, 113], "imshow": 113, "colorbar": 113, "361149": 113, "isi": 113, "phys_ovov": 113, "iiss": 113, "diag_el": 113, "15pt": 113, "v1x": 113, "v1y": 113, "v1z": 113, "vmtrx": 113, "vx": 113, "vmin": 113, "vmax": 113, "vy": 113, "133": [113, 150, 156], "vz": 113, "005214": 113, "dipole_matric": [113, 144], "x_ao": [113, 144], "x_mo": [113, 144], "_e": 113, "9pt": 113, "3pt": 113, "nonsingular": 113, "8pt": 113, "emphas": 113, "29153356": 113, "35199506": 113, "36380664": 113, "36860999": 113, "38443182": 113, "42735114": 113, "47252353": 113, "49752266": 113, "4993755": 113, "54458488": 113, "54825333": 113, "55314321": 113, "dagger_f": 113, "compute_fosc": 113, "nrefer": 113, "558630e": 113, "000000e": 113, "160000e": 113, "257950e": 113, "118172e": 113, "55864e": 113, "00000e": 113, "16000e": 113, "25793e": 113, "11817e": 113, "9893": [113, 156], "9782": 113, "9966": 113, "9766": 113, "9895": 113, "9691": 113, "9710": 113, "2150": 113, "9591": [113, 153], "2531": 113, "9904": 113, "9684": 113, "8945": 113, "3767": 113, "sought": [113, 133], "funciton": 113, "dictonari": 113, "alpha_yi": 113, "alpha_zz": 113, "985929": 113, "268122": 113, "201365": 113, "nx": 113, "ny": 113, "nz": 113, "018986": 113, "491345": 113, "244817": 113, "phenomenolog": 113, "sound": 113, "nonreson": 113, "kramer": 113, "kronig": 113, "cpp_drv": [113, 124, 144], "cpp_out": 113, "yr": 113, "57868869": 115, "00818369": 115, "22485575": 115, "60189688": 115, "76762482": 115, "tdaexcidriv": [115, 122], "tda_drv": [115, 144], "57868811": 115, "00818379": 115, "22485652": 115, "60189672": 115, "76762549": 115, "tpa": 117, "sf": 117, "0m": 117, "m0": 117, "colour": 117, "nonvari": 117, "aristotl": 119, "bohr_to_\u00e5": 120, "eq_molecul": 120, "eq_orbit": 120, "eq_2dens": 120, "499278403420": 120, "00000005": 120, "00000003": [120, 143, 148], "4992784034": 120, "0000000462": 120, "7500": 120, "49928": 120, "57244": 120, "44303": 120, "07335": 120, "75329": 120, "57364": 120, "0583544218": 120, "044195881437": 120, "048687184260": 120, "03228141": 120, "00976213": 120, "048800398179": 120, "0001132139": 120, "00075218": 120, "00019687": 120, "00838820": 120, "048800556215": 120, "0000001580": 120, "00000986": 120, "00000323": 120, "00041723": 120, "048800556227": 120, "00000326": 120, "0488005562": 120, "1071549780": 120, "0000000051": 120, "67746": 120, "23819": 120, "42154": 120, "16876": 120, "33275": 120, "079370051": 120, "0793700508928035": 120, "97719": 120, "00008": 120, "00501": 120, "00970": 120, "00380": 120, "00013": 120, "8819620182": 120, "102601746873": 120, "106788495584": 120, "03045659": 120, "00841139": 120, "106892338747": 120, "0001038432": 120, "00069812": 120, "00020665": 120, "00725834": 120, "106892475138": 120, "0000001364": 120, "00000920": 120, "00000317": 120, "00039011": 120, "106892475152": 120, "00000386": 120, "1068924752": 120, "9888544933": 120, "0000000057": 120, "63879": 120, "22260": 120, "44547": 120, "05754": 120, "31355": 120, "139173293": 120, "1391732932951475": 120, "97340": 120, "00564": 120, "00016": 120, "00011": 120, "7559674441": 120, "122770998276": 120, "126826026762": 120, "02918562": 120, "00724027": 120, "126924576362": 120, "0000985496": 120, "00064391": 120, "00020404": 120, "00640409": 120, "126924692283": 120, "0000001159": 120, "00000970": 120, "00000342": 120, "00036324": 120, "126924692303": 120, "00000477": 120, "1269246923": 120, "8828921364": 120, "0000000192": 120, "60482": 120, "20498": 120, "46968": 120, "96759": 120, "29782": 120, "160904682": 120, "1609046824806657": 120, "96871": 120, "00602": 120, "00331": 120, "00019": 120, "00014": 120, "7055696145": 120, "124608367719": 120, "128645660151": 120, "02872496": 120, "00752087": 120, "128743027026": 120, "0000973669": 120, "00062088": 120, "00020101": 120, "00607432": 120, "128743134729": 120, "0000001077": 120, "00001024": 120, "00000362": 120, "00035226": 120, "128743134753": 120, "00000526": 120, "1287431348": 120, "8343127493": 120, "0000000210": 120, "58941": 120, "19551": 120, "48172": 120, "93020": 120, "29182": 120, "163593561": 120, "1635935606538312": 120, "96588": 120, "02104": 120, "00611": 120, "00314": 120, "00020": 120, "6614715136": 120, "122863755794": 120, "126903786231": 120, "02833405": 120, "00776828": 120, "127000620590": 120, "0000968344": 120, "00059929": 120, "00019720": 120, "00578585": 120, "127000720853": 120, "0000001003": 120, "00001092": 120, "00000385": 120, "00034224": 120, "127000720883": 120, "00000582": 120, "1270007209": 120, "7884722345": 120, "0000000052": 120, "57494": 120, "18567": 120, "49365": 120, "89695": 120, "28732": 120, "162750763": 120, "1627507630215632": 120, "96266": 120, "02457": [120, 143], "00613": 120, "00017": 120, "00296": 120, "00022": [120, 144], "5879746788": 120, "112220769289": 120, "116294268816": 120, "02764470": 120, "00815308": 120, "116391213357": 120, "0000969445": 120, "00055877": 120, "00018803": 120, "00530657": 120, "116391300399": 120, "0000000870": 120, "00001254": 120, "00000437": 120, "00032420": 120, "116391300440": 120, "00000699": 120, "1163913004": 120, "7043659792": 120, "0000000013": [120, 143], "54852": 120, "16505": 120, "51701": 120, "84044": 120, "28349": 120, "154081706": 120, "1540817061165314": 120, "95470": 120, "03339": 120, "00599": 120, "00025": 120, "00002": 120, "140073481": 120, "1400734808710469": 120, "94416": 120, "04503": 120, "00565": 120, "00027": 120, "4409810091": 120, "057057778249": 120, "061017008512": 120, "02498883": 120, "00837395": 120, "061111945190": 120, "0000949367": 120, "00043469": 120, "00015110": 120, "00450475": 120, "061111997775": 120, "0000000526": 120, "00001623": 120, "00000553": 120, "00026831": 120, "061111997850": 120, "00000968": 120, "0611119978": 120, "5020930069": 120, "0000000004": [120, 143], "48526": 120, "10025": 120, "58296": 120, "72928": 120, "31531": 120, "106855193": 120, "1068551925482586": 120, "91211": 120, "07966": 120, "00030": 120, "3527848073": 120, "999019668155": 120, "002120347046": 120, "02044695": 120, "00718048": 120, "002192720639": 120, "0000723736": 120, "00029841": 120, "00010488": 120, "00418857": 120, "002192745431": 120, "0000000248": 120, "00001282": 120, "00000447": 120, "00019427": 120, "002192745478": 120, "00000804": 120, "0021927455": 120, "3549775527": 120, "43916": 120, "04030": 120, "64366": 120, "67571": 120, "27713": 120, "38302": 120, "061534950": 120, "0615349496254003": 120, "82407": 120, "17146": 120, "00246": 120, "00026": 120, "00065": 120, "2645886055": 120, "920706243669": 120, "921886356635": 120, "01150627": 120, "00406041": 120, "921908589697": 120, "0000222331": 120, "00012300": 120, "00004281": 120, "00260878": 120, "921908594102": 120, "0000000044": 120, "00000367": 120, "00000128": [120, 143], "00008607": 120, "921908594106": 120, "00000249": 120, "9219085941": 120, "1864971996": 120, "38571": 120, "03585": 120, "65320": 120, "67021": 120, "34213": 120, "45332": 120, "017594114": 120, "0175941140438802": 120, "56605": 120, "43300": 120, "00006": 120, "00010": 120, "00004": 120, "2116708844": 120, "864890569654": 120, "865323130286": 120, "00662539": 120, "00233203": 120, "865330119957": 120, "0000069897": 120, "00002402": 120, "00000842": 120, "00153364": 120, "865330120137": 120, "00000130": 120, "00000045": 120, "00001924": 120, "865330120138": 120, "00000098": 120, "8653301201": 120, "0770010045": 120, "34934": 120, "08466": 120, "62463": 120, "66777": 120, "45319": 120, "46317": 120, "003129251": 120, "003129251227058": 120, "30747": 120, "69238": 120, "1763924036": 120, "826215752307": 120, "826444448804": 120, "00461717": 120, "00162670": 120, "826447843878": 120, "0000033951": 120, "00000214": [120, 148], "00000076": [120, 143], "00110952": 120, "826447843880": 120, "00000021": 120, "00000007": [120, 143], "00000161": 120, "8264478439": 120, "0028402475": 120, "0000002057": 120, "32328": 120, "11576": 120, "59484": 120, "67845": 120, "46177": 120, "999550619": 120, "9995506185969377": 120, "15006": 120, "84991": 120, "1511934888": 120, "799871798054": 120, "799991332224": 120, "00320033": 120, "00112755": 120, "799992972433": 120, "0000016402": 120, "00000479": 120, "00000169": 120, "00078939": 120, "799992972441": 120, "00000017": 120, "00000006": [120, 143], "00000407": [120, 143], "7999929724": 120, "9511864613": 120, "0000001692": 120, "30398": 120, "13570": 120, "59106": 120, "67000": 120, "46240": 120, "998771056": 120, "9987710557416043": 120, "07018": 120, "92981": 120, "1322943027": 120, "782139853255": 120, "782197472959": 120, "00214017": 120, "00075393": 120, "782198208427": 120, "0000007355": 120, "00000243": 120, "00000086": [120, 143], "00053449": 120, "782198208429": 120, "00000212": 120, "7821982084": 120, "9144925112": 120, "0000000737": 120, "28967": 120, "14868": 120, "60146": 120, "65436": 120, "46422": 120, "46443": 120, "998606186": 120, "9986061861413569": 120, "03178": 120, "96822": 120, "1175949358": 120, "770215954354": 120, "770245883432": 120, "00149442": 120, "00052645": 120, "770246242419": 120, "0000003590": 120, "00000095": 120, "00000034": 120, "00037504": 120, "7702462424": 120, "8878411782": 120, "0000009489": 120, "27925": 120, "15756": 120, "61352": 120, "64164": 120, "46607": 120, "46635": 120, "998569095": 120, "99856909473122": 120, "01383": 120, "98617": 120, "1058354422": 120, "762026297205": 120, "762044195778": 120, "00112546": 120, "00039650": 120, "762044399480": 120, "0000002037": 120, "00000038": 120, "00000013": [120, 143], "00028293": 120, "7620443995": 120, "8678798417": 120, "0000003765": 120, "27168": 120, "16408": 120, "62166": 120, "63412": 120, "46736": 120, "46760": 120, "998559877": 120, "9985598772014367": 120, "00568": 120, "99432": 120, "length_includes_head": 120, "head_width": 120, "head_length": 120, "edgecolor": 120, "whenev": [120, 157], "truli": 120, "ethen": [120, 131, 133, 142, 143, 153], "923274": 120, "238289": 120, "668188": 120, "eht": 120, "orbitalguess": 120, "guessorb": 120, "cas_orbit": [120, 124, 144], "mcscfdrv": 120, "mcresult": 120, "sv_p_": 120, "737843601": 120, "976388879": 120, "016080942": 120, "019128794": 120, "019331249": 120, "019362607": 120, "019365983": 120, "019366505": 120, "019366536": 120, "019366538": 120, "0193665376418": 120, "98365": 120, "92629": 120, "07350": 120, "01656": 120, "77861": 120, "63704": 120, "50339": 120, "984": 120, "74951": 120, "36398": 120, "074": 120, "26140": 120, "96850": 120, "20754": 120, "23435": 120, "25745": 120, "98365468": 120, "92628668": 120, "07349929": 120, "01655935": 120, "ipython": [120, 133], "ethene_bond_break": 120, "coords_shift": 120, "sigma_max": 120, "argmax": 120, "pi_max": 120, "shorter": 120, "frustrat": 120, "arguabl": [120, 122], "mild": 120, "famou": 120, "chromium": 120, "9p": 120, "427350": 120, "2086": [120, 156], "226771425": 120, "292217657": 120, "303001849": 120, "305479044": 120, "305829379": 120, "305864713": 120, "305869953": 120, "305870598": 120, "305870706": 120, "305870726": 120, "305870730": 120, "305870729": 120, "305870729343": 120, "91210": 120, "81415": 120, "78607": 120, "59980": 120, "40096": 120, "20939": 120, "18598": 120, "09065": 120, "11529": 120, "03811": 120, "912": 120, "20539": 120, "28977": 120, "786": 120, "26152": 120, "2d0": 120, "15528": 120, "401": 120, "12625": 120, "28096": 120, "186": 120, "27552": 120, "07388": 120, "3p0": 120, "10910": 120, "12124": 120, "000051": 120, "91210146": 120, "81415425": 120, "81415422": 120, "78607309": 120, "59979678": 120, "59979666": 120, "40096061": 120, "40096047": 120, "20939453": 120, "18597783": 120, "18597781": 120, "0906523": 120, "uhf": [121, 143, 144, 145, 148], "unpair": 122, "proce": 122, "earth": 122, "au2kcal": 122, "rodft": 122, "triplet_rodft_drv": 122, "triplet_rodft_result": 122, "triplet_udft_drv": 122, "triplet_udft_result": 122, "ow": 122, "rob3lyp": 122, "ub3lyp": 122, "33014560": 122, "33392791": 122, "78650": 122, "52369": 122, "50972": 122, "20092": 122, "23772": 122, "79595": 122, "83473": 122, "56129": 122, "54325": 122, "29937": 122, "21614": 122, "78644": 122, "80682": 122, "89114": 122, "25526": 122, "74211": 122, "50336": 122, "45864": 122, "10410": 122, "26034": 122, "80590": 122, "86451": 122, "006227": 122, "triplet_rohf_drv": 122, "triplet_rohf_result": 122, "triplet_mcscf_drv": 122, "singlet_rdft_drv": 122, "singlet_rdft_result": 122, "79052": 122, "52746": 122, "51773": 122, "50968": 122, "24089": 122, "17013": 122, "23373": 122, "79320": 122, "82293": 122, "84078": 122, "92128398": 122, "29472211": 122, "rsp_drv": [122, 153], "rsp_result": [122, 153], "732361": 122, "18892342": 122, "56236155": 122, "singlet_udft_drv": 122, "singlet_udft_result": 122, "rdft": 122, "27130784": 122, "impetu": 122, "stuck": 122, "a_occ": 122, "b_occ": 122, "broken_udft_drv": 122, "broken_udft_result": 122, "01237": 122, "80124": 122, "51076": 122, "20217": 122, "91738": 122, "65807": 122, "34841": 122, "308167": 122, "003282": 122, "61633376": 122, "wab": 122, "singlet_mcscf_drv": 122, "69991698": 122, "spin_restrict": 122, "all_mcscf_drv": 122, "55599147": 122, "11198294": 122, "ly": [122, 141, 143, 144, 149], "great": 122, "large_mcscf_drv": 122, "00271262": 122, "02178824": 122, "707": 122, "jablonski": 123, "timescal": 123, "intersystem": 123, "phosphoresc": 123, "ultrafast": 123, "femtosecond": 123, "onto": [123, 144], "vibration": 123, "gound": 123, "vibrationali": 123, "inten": 123, "gridspec": [124, 144], "gaseou": 124, "rpa_solv": [124, 151, 153], "lreigensolv": [124, 151, 153], "rpa_result": [124, 144, 151, 153], "286": [124, 136, 151], "24321": [124, 151], "364": [124, 151], "09652": [124, 151], "63080": [124, 151], "454": [124, 151, 156], "08684": [124, 151], "53570": [124, 151], "540": [124, 144, 148, 151], "41655": [124, 151], "07524": [124, 151], "24377": [124, 151], "74073": [124, 151], "freqs_str": [124, 142, 144], "rsplinabscross": [124, 144], "linearabsorptioncrosssect": [124, 142, 144], "init_driv": [124, 142, 144], "cpp_result": [124, 144], "axx": [124, 142, 144], "rsp_properti": [124, 142, 144], "ayi": [124, 142, 144], "azz": [124, 142, 144], "alpha_bar": [124, 142, 144], "035999": [124, 142, 144], "raw": [124, 144], "width_ratio": [124, 144], "bx": [124, 144], "get_molecul": [124, 125, 142, 144, 145, 153], "get_molecular_basi": [124, 125, 142, 144, 145, 153], "scf_g": [124, 125, 136, 142, 143, 144, 145, 148, 153], "adc_result": [124, 144, 153], "adc3": [124, 143], "resul": 124, "convolut": [124, 144, 145, 151], "adc2": [124, 125, 143, 144, 145, 148, 153], "plot_spectrum": [124, 125, 143, 144, 145, 148], "xaxi": 124, "222": [124, 143, 144], "nm": [124, 130, 131, 132, 150, 156], "224": [124, 143], "v2": [124, 125, 144, 145, 153], "3127134": 124, "509364": 124, "0134": [124, 156], "951": 124, "04895": 124, "3933877": 124, "70463": 124, "9532": 124, "04681": 124, "4056694": 124, "03883": 124, "1161": [124, 156], "9491": 124, "05091": 124, "4916579": 124, "37869": 124, "949": [124, 156], "05096": 124, "5655096": 124, "3883": 124, "4351": 124, "9625": 124, "03751": 124, "6977152": 124, "9858": 124, "2604": 124, "9537": 124, "04626": 124, "discret": [124, 144], "flatten": [124, 144], "suspect": 124, "conic": 124, "someth": [124, 148], "tradit": 124, "compris": 124, "617648941": 124, "642903350": 124, "646125925": 124, "646212175": 124, "646218727": 124, "646219045": 124, "646219063": 124, "646219065": 124, "98281062496625": 124, "98486": 124, "99960": 124, "00851": 124, "70404926196608": 124, "98828": 124, "99728": 124, "99912": 124, "01531": 124, "62045138647316": 124, "99530": 124, "99422": 124, "01264": 124, "99784": 124, "60225041976662": 124, "96141": 124, "99969": 124, "22263": 124, "77478": 124, "04148": 124, "52004110975072": 124, "97752": 124, "01676": 124, "02746": 124, "97865": 124, "44771158728813": 124, "01935": 124, "99895": 124, "97990": 124, "02395": 124, "68879": 124, "45143": 124, "816": 124, "76930": 124, "52443": 124, "59973": 124, "501": 124, "10225": 124, "351": 124, "21690": 124, "99875": 124, "06993": 124, "848594": 124, "156911": 124, "088075": 124, "223865": 124, "019117": 124, "048591": 124, "127030": 124, "322878": 124, "138716": 124, "352582": 124, "255728": 124, "649995": 124, "58548": 124, "220177e": 124, "799370e": 124, "35557": 124, "097829e": 124, "281789e": 124, "59260": 124, "545515e": 124, "469851e": 124, "56079": 124, "993553e": 124, "307390e": 124, "01220": 124, "381": [124, 156], "10978": 124, "463": 124, "15455": 124, "535": [124, 144], "59936": 124, "rspdict": [124, 144], "991165249": 124, "005855741": 124, "031621117": 124, "034371736": 124, "036920247": 124, "037128966": 124, "037231330": 124, "037270318": 124, "037273265": 124, "037273978": 124, "037274020": 124, "03727403227734": 124, "55476": 124, "07550": 124, "83333": 124, "70219": 124, "75293": 124, "73231": 124, "67761": 124, "78417": 124, "983137": 124, "498886": 124, "711592304": 124, "532277685": 124, "472274167": 124, "455154316": 124, "453380481": 124, "452031444": 124, "451970822": 124, "451896428": 124, "451894976": 124, "451891023": 124, "451890969": 124, "451890957": 124, "3305189": 124, "99388": 124, "0389564": 124, "4084659": 124, "11492": 124, "4307432": 124, "72112": 124, "1738586": 124, "1284586": 124, "5110794": 124, "90718": 124, "1450281": 124, "1453586": 124, "5786474": 124, "74580": 124, "3465044": 124, "4062187": 124, "set_figheight": 124, "set_figwidth": 124, "silent_ostream": [125, 145], "mpi4pi": [125, 145], "comm_world": [125, 145], "ch3oh_mol_str": 125, "6627602692": 125, "0195253241": 125, "7482324502": 125, "1217146925": 125, "0282229693": 125, "5397922417": 125, "8872632580": 125, "0781531801": 125, "9835591659": 125, "1253011321": 125, "7605402778": 125, "struct": [125, 142, 144, 145], "adc_r": [125, 145], "3876414915": 125, "986646483208": 125, "986647455185": 125, "00019765": 125, "00003189": 125, "986647466155": 125, "0000000110": 125, "00008804": 125, "00001229": 125, "00014964": 125, "986647467682": 125, "0000000015": 125, "00001316": 125, "00000245": 125, "00005028": 125, "986647467711": 125, "00000768": 125, "00000123": 125, "00000788": 125, "986647467718": 125, "00000092": 125, "00000020": 125, "00000271": 125, "9866474677": 125, "3742889592": 125, "0000009201": 125, "68674": 125, "62359": 125, "58786": 125, "49474": 125, "44686": 125, "21888": 125, "27257": 125, "31271": 125, "32064": 125, "37611": 125, "23909": 125, "228m": 125, "40241316": 125, "48084642": 125, "51034518": 125, "52072285": 125, "55248738": 125, "55772689": 125, "010561": 125, "456m": 125, "29557131": 125, "37845885": 125, "39618815": 125, "4170348": 125, "44699784": 125, "45009195": 125, "0038423": 125, "670m": 125, "29423544": 125, "37469582": 125, "38629969": 125, "41095523": 125, "43604013": 125, "43686795": 125, "00035144": 125, "839m": 125, "29417706": 125, "37426126": 125, "38422222": 125, "40954519": 125, "43305633": 125, "43490802": 125, "7396e": 125, "29417387": 125, "37422958": 125, "38413954": 125, "40949836": 125, "43288848": 125, "43484835": 125, "5709e": 125, "898m": 125, "29417373": 125, "37422705": 125, "3841368": 125, "40949611": 125, "4328759": 125, "43484511": 125, "3958e": 125, "713m": 125, "29417371": 125, "37422666": 125, "38413652": 125, "40949598": 125, "43287347": 125, "43484478": 125, "886m": 125, "2941737": 125, "004874": 125, "9527": 125, "04731": 125, "3742267": 125, "18323": 125, "0109": [125, 153, 156], "9533": 125, "04671": 125, "3841365": 125, "45289": 125, "0868": [125, 156], "9329": 125, "06713": 125, "409496": 125, "14295": 125, "9455": 125, "05445": 125, "4328735": 125, "77909": 125, "1071": [125, 156], "9252": 125, "07478": 125, "4348448": 125, "83273": 125, "0266": [125, 156], "9439": 125, "05607": 125, "describe_amplitud": [125, 142, 153], "652": 125, "0575": [125, 156], "0233": [125, 156], "0232": [125, 156], "0206": [125, 156], "0196": [125, 156], "0175": [125, 156], "0165": [125, 156], "0105": [125, 156], "0157": [125, 156], "012": 125, "0117": [125, 153, 156], "0116": [125, 156], "0798": [125, 156], "0596": [125, 156], "0456": [125, 156], "0436": [125, 156], "0369": [125, 156], "0291": [125, 156], "0278": [125, 156], "0198": [125, 156], "015": 125, "0133": [125, 153, 156], "0126": [125, 156], "0187": [125, 156], "0146": [125, 156], "0118": [125, 156], "0102": [125, 156], "0918": [125, 156], "0871": [125, 156], "0437": [125, 156], "0258": [125, 156], "0192": [125, 156], "0167": [125, 156], "0199": [125, 156], "0179": [125, 156], "0149": [125, 156], "0122": [125, 156], "0113": [125, 156], "0111": [125, 156], "529": 125, "389": 125, "0715": [125, 156], "0705": [125, 156], "0628": [125, 156], "0623": [125, 156], "0354": [125, 156], "0261": [125, 156], "0239": [125, 156], "0151": [125, 156], "0148": [125, 156], "0138": [125, 156], "013": [125, 153], "0106": [125, 156], "0101": [125, 156], "119": [125, 156], "0857": [125, 156], "0766": [125, 156], "0627": [125, 156], "0411": [125, 156], "027": 125, "0202": [125, 156], "0147": [125, 153, 156], "0144": [125, 153, 156], "0115": [125, 153, 156], "0346": [125, 156], "0197": [125, 156], "0194": [125, 156], "0178": [125, 144, 145, 156], "0143": [125, 153, 156], "0132": [125, 156], "0119": [125, 156], "0104": [125, 153, 156], "0103": [125, 156], "404": 125, "0685": [125, 156], "0624": [125, 156], "0513": [125, 156], "0464": [125, 156], "0256": [125, 156], "0242": [125, 156], "0203": [125, 156], "0164": [125, 156], "0135": [125, 156], "0129": [125, 156], "0125": [125, 156], "0112": [125, 156], "narrow": 125, "strongest": 125, "toler": [125, 142], "split_r": 125, "sim0": 125, "transition_dipole_mo": [125, 142], "10570323e": 125, "50586668e": 125, "82241208e": 125, "17627387e": 125, "21072518e": 125, "16603011e": 125, "favorit": 126, "agre": 126, "disagre": 126, "protocol": [126, 148], "expert": [128, 149], "incomplet": [128, 149], "unavoid": [128, 149], "bias": [128, 149], "cc2": [128, 149], "tendenc": [128, 143], "cpp": [128, 142, 143, 149], "heavili": [128, 143, 148], "advis": [128, 133, 143], "might": [128, 133, 143, 144], "safest": [128, 149], "dun": [128, 143, 149], "rydberg": [128, 144, 149, 150], "elast": 129, "stoke": 129, "ultraviolet": 129, "tune": [129, 141, 143], "yellow": [129, 159], "promot": 130, "coval": 130, "epsilon_0c": 130, "k0": 130, "fingerprint": 130, "identif": 130, "950": 130, "896": 130, "317": 130, "hessian_drv": 130, "print_hessian": 130, "hood": 130, "vibrational_analysi": [130, 131, 132, 156], "list_ex_energi": [130, 131, 132, 156], "list_osci_strength": [130, 131, 132, 156], "line_param": [130, 131, 132, 156], "amin": [130, 131, 132, 156], "amax": [130, 131, 132, 156], "xp": [130, 131, 132, 141, 143, 144, 149, 156], "ir_intens": [130, 131, 156], "x1i": [130, 142], "y1i": [130, 142], "sepctrum": [130, 156], "symmetryc": 130, "bend": 130, "get_normal_mod": [130, 131, 132, 156], "normal_mod": [130, 131, 132, 156], "natm": [130, 131, 132, 153, 156], "vib_xyz": [130, 131, 132, 156], "vib_1": 130, "vib_2": 130, "vib_3": 130, "1927": 130, "4545": [130, 156], "4896": 130, "663984": 131, "919796": 131, "223061": 131, "ethene_basi": 131, "fluoroethene_xyz": 131, "fluoroethen": 131, "519796": 131, "fluoroethene_basi": 131, "chloroethene_xyz": 131, "chloroethen": 131, "chloroethene_basi": 131, "ethene_scf_drv": 131, "fluoroethene_scf_drv": 131, "chloroethene_scf_drv": 131, "ethene_scf_result": 131, "fluoroethene_scf_result": 131, "chloroethene_scf_result": 131, "ethene_grad_drv": 131, "fluoroethene_grad_drv": 131, "chloroethene_grad_drv": 131, "ethene_opt_drv": 131, "fluoroethene_opt_drv": 131, "chloroethene_opt_drv": 131, "opt_ethen": 131, "opt_fluoroethen": 131, "opt_chloroethen": 131, "uncom": [131, 156], "unmut": 131, "ir_raman": [131, 132], "get_xyz": 131, "hessian_set": [131, 132], "do_raman": [131, 132], "print_depolarization_ratio": [131, 132], "ethene_hessian_drv": 131, "fluoroethene_hessian_drv": 131, "chloroethene_hessian_drv": 131, "h5py": [131, 132, 156], "fname": [131, 132, 156], "h5": [131, 132, 143, 156], "_hessian": [131, 132], "dipole_gradi": [131, 132, 156], "_dipolegrad": [131, 132], "polarizability_gradi": [131, 132], "_polgrad": [131, 132], "eth_x": 131, "eth_ir": 131, "flo_x": 131, "flo_ir": 131, "chl_x": 131, "chl_ir": 131, "eth_xl": 131, "eth_irl": 131, "flo_xl": 131, "flo_irl": 131, "chl_xl": 131, "chl_irl": 131, "3200": [131, 156], "3500": [131, 156], "sepctra": [131, 132], "eth_raman": 131, "raman_intens": [131, 132], "flo_raman": 131, "chl_raman": 131, "eth_ramanl": 131, "flo_ramanl": 131, "chl_ramanl": 131, "amu": [131, 132, 156], "ethene_h1": 131, "fluoroethene_h1": 131, "chloroethene_h1": 131, "ration": 131, "ethene_prop": 131, "compute_scf_prop": 131, "ethene_dipole_mo": 131, "fluoroethene_prop": 131, "fluoroethene_dipole_mo": 131, "chloroethene_prop": 131, "chloroethene_dipole_mo": 131, "ethene_mo": 131, "fluoroethene_mo": 131, "new_ethene_scf_drv": 131, "ethene_displac": 131, "ethene_label": 131, "new_fluoroethene_scf_drv": 131, "fluoroethene_displac": 131, "fluoroethene_label": 131, "x_list": 131, "ethene_coord": 131, "new_ethen": 131, "new_ethene_scf_result": 131, "fluoro_coord": 131, "new_fluoroethen": 131, "new_fluoroethene_scf_result": 131, "ethene_moments_arrai": 131, "fluoroethene_moments_arrai": 131, "plt1": 131, "plt2": 131, "ethene_lrdrv": 131, "lrsolver": 131, "ethene_pol_dict": 131, "ethene_polariz": 131, "fluoroethene_lrdrv": 131, "fluoroethene_pol_dict": 131, "fluoroethene_polariz": 131, "chloroethene_lrdrv": 131, "chloroethene_pol_dict": 131, "chloroethene_polariz": 131, "ethene_pol": 131, "fluoroethene_pol": 131, "new_ethene_lrdrv": 131, "new_fluoroethene_lrdrv": 131, "new_ethene_pol_dict": 131, "new_fluoroethene_pol_dict": 131, "ethene_polarizability_arrai": 131, "fluoroethene_polarizability_arrai": 131, "inelas": 132, "nh": [132, 143], "ch": [132, 133, 136, 139, 142, 143, 144], "opt_h2o": 132, "nh3_xyz": 132, "opt_nh3": 132, "ch4_xyz": 132, "opt_ch4": 132, "h2o_basi": 132, "nh3": 132, "nh3_basi": 132, "ch4": 132, "ch4_basi": 132, "h2o_scf_drv": 132, "h2o_result": [132, 136], "nh3_scf_drv": 132, "nh3_result": 132, "ch4_scf_drv": 132, "ch4_result": [132, 136], "h2o_hessian_drv": 132, "nh3_hessian_drv": 132, "ch4_hessian_drv": 132, "h2o_x": 132, "h2o_i": 132, "nh3_x": 132, "nh3_y": 132, "ch4_x": 132, "ch4_y": 132, "h2o_xl": 132, "h2o_yl": 132, "nh3_xl": 132, "nh3_yl": 132, "ch4_xl": 132, "ch4_yl": 132, "h2o_h1": 132, "h2o_h2": 132, "nh3_h1": 132, "nh3_h2": 132, "nh3_h3": 132, "ch4_h1": 132, "ch4_h2": 132, "ch4_h3": 132, "ch4_h4": 132, "entri": 133, "bank": 133, "babel": [133, 139], "caffein": 133, "smiles_str": 133, "cn1c": 133, "nc2": 133, "c1c": 133, "n2c": 133, "caffeine_molecul": 133, "mmff94": [133, 139], "caffeine_xyz": 133, "246030000000": 133, "130310000000": 133, "025980000000": 133, "262080000000": 133, "077920000000": 133, "007760000000": 133, "516750000000": 133, "268080000000": 133, "001470000000": 133, "402970000000": 133, "973590000000": 133, "005650000000": 133, "410650000000": 133, "040380000000": 133, "000280000000": 133, "905090000000": 133, "228440000000": 133, "004840000000": 133, "080570000000": 133, "385890000000": 133, "010540000000": 133, "536520000000": 133, "525370000000": 133, "015680000000": 133, "283180000000": 133, "078550000000": 133, "010220000000": 133, "833810000000": 133, "220410000000": 133, "006860000000": 133, "056760000000": 133, "390670000000": 133, "007920000000": 133, "939960000000": 133, "291810000000": 133, "003250000000": 133, "425170000000": 133, "659750000000": 133, "004880000000": 133, "230720000000": 133, "175770000000": 133, "018140000000": 133, "247690000000": 133, "693450000000": 133, "002350000000": 133, "117910000000": 133, "709050000000": 133, "944170000000": 133, "099090000000": 133, "761210000000": 133, "854070000000": 133, "519330000000": 133, "677350000000": 133, "002970000000": 133, "517080000000": 133, "705220000000": 133, "028990000000": 133, "035370000000": 133, "176560000000": 133, "887670000000": 133, "073880000000": 133, "164310000000": 133, "900710000000": 133, "742510000000": 133, "153400000000": 133, "018220000000": 133, "861160000000": 133, "094140000000": 133, "909710000000": 133, "871610000000": 133, "099260000000": 133, "866370000000": 133, "smiles_to_xyz": [133, 136], "svg": 133, "draw_2d": 133, "sequenti": [133, 140], "alkan": [133, 136], "methane_xyz": 133, "ethane_xyz": 133, "propane_xyz": 133, "ccc": 133, "butane_xyz": 133, "cccc": 133, "ethyn": 133, "ethyne_xyz": 133, "paranthesi": 133, "nest": 133, "hexan": 133, "ethylheptan": 133, "hexane_xyz": 133, "cccccc": 133, "ethylheptane_xyz": 133, "ccccc": 133, "difluoroethen": [133, 142, 146], "difluoro11_xyz": 133, "difluoro12_xyz": 133, "ethanol": 133, "stagger": [133, 139], "ethanol_initial_xyz": 133, "ethanol_xyz": 133, "cyclohexan": 133, "norbornan": 133, "cyclohexane_xyz": 133, "c1ccccc1": 133, "norborane_xyz": 133, "c1c2ccc": 133, "c1": [133, 143], "aromat": 133, "cymen": 133, "pcymene1_xyz": 133, "pcymene2_xyz": 133, "c1ccc": 133, "cc1": 133, "chemspid": 133, "digit": [133, 142], "nadh": 133, "nad": 133, "nicotinamid": 133, "adenin": 133, "dinucleotid": 133, "partak": 133, "metabol": 133, "redox": 133, "longleftrightarrow": 133, "nadh_xyz": 133, "c1cc": 133, "2o": 133, "cop": 133, "op": 133, "5o": 133, "n4cnc3c": 133, "ncnc34": 133, "nadp_xyz": 133, "urllib": 133, "urlopen": 133, "1aoi": 133, "rcsb": 133, "decod": 133, "utf": 133, "setbackgroundcolor": 133, "methan": 134, "combust": 134, "warm": 134, "gwp": 134, "gase": [134, 141], "reactant": 136, "paper": [136, 153], "compet": 136, "extrapol": 136, "ch4_ff": 136, "h2o_ff": 136, "co2_ff": 136, "o2_ff": 136, "xtb_optim": 136, "xyz_ff": 136, "xtb_drv": [136, 139, 156], "xtb_opt_drv": [136, 139], "xtb_opt": 136, "ch4_xtb": 136, "h2o_xtb": 136, "co2_xtb": 136, "o2_xtb": 136, "mind": [136, 140, 143, 150], "scf_calcul": 136, "molecule_xyz": 136, "ch4_scf": 136, "o2_result": 136, "o2_scf": 136, "co2_result": 136, "co2_scf": 136, "h2o_scf": 136, "e_react": 136, "e_product": 136, "hydrocarbon": 136, "143": 136, "propan": 136, "138": [136, 156], "butan": 136, "544": [136, 144], "heptan": 136, "134": [136, 156], "362051846542": 137, "008519935441": 137, "024906559609": 137, "933468973663": 137, "509856441784": 137, "193822841148": 137, "483698601596": 137, "368885697455": 137, "046180408743": 137, "612499226929": 137, "790059463155": 137, "682044832355": 137, "045997965440": 137, "841433017766": 137, "127103979461": 137, "570778666846": 137, "200864234382": 137, "068115315388": 137, "scf_hf": 137, "hf_result": 137, "01894": 137, "isovalu": 137, "scf_b3lyp": 137, "b3lyp_result": 137, "71437": 137, "methanol_ff": 139, "xtb_opt_result": 139, "methanol_xtb": 139, "methanol_hf": 139, "dm_ff": 139, "get_distance_matrix_in_angstrom": 139, "dm_xtb": 139, "dm_hf": 139, "nan": 139, "dm_tmp": 139, "1e10": 139, "physicochem": 140, "sectroscopi": 141, "photoemiss": 141, "photoion": 141, "xe": [141, 143, 144, 146, 149], "decai": [141, 144, 146, 148], "rix": [141, 143, 144, 145, 149], "abil": [141, 144], "nobl": 141, "nist": 141, "siegbahn": 141, "shield": [141, 143, 144, 150], "necessit": [141, 147], "tailor": [141, 142, 147], "continumm": 141, "exot": [141, 148], "cheat": 141, "sheet": 141, "vinylfluorid": [142, 143], "emphasi": 142, "thereof": 142, "date": 142, "vinylflurid": 142, "fluorin": [142, 143, 144], "electroneg": [142, 144], "deliber": 142, "vinyl_mol_str": [142, 143], "246412": [142, 143], "271068": [142, 143], "457081": [142, 143], "154735": [142, 143], "119195": [142, 143], "052878": [142, 143], "272328": [142, 143], "210194": [142, 143], "319906": [142, 143], "249847": [142, 143], "530323": [142, 143], "095954": [142, 143], "adc_xa": [142, 144, 148], "adc2x": [142, 143, 144, 145], "core_orbit": [142, 143, 144, 145, 148], "mismatch": 142, "conda": 142, "272": 142, "cpp_prop": 142, "284": 142, "280": 142, "296": 142, "index_format": 142, "des_amp": 142, "split_lin": 142, "tmp_amp": 142, "hf_exc1": 142, "hf_exc2": 142, "nfirst": 142, "adcc_exc1": 142, "homolumo": 142, "hoco": 142, "homo_exc1": 142, "63675": 142, "601": [142, 144], "4407": 142, "adc_chf": 142, "adc_ch2": 142, "chf": 142, "x2i": 142, "y2i": 142, "philosophi": [142, 149], "number_mo": 142, "solution_vec": 142, "x_solut": 142, "y_solut": 142, "z_solut": 142, "sx": 142, "sy": 142, "sz": 142, "spec_comp": 142, "x_tmp": [142, 144], "y_tmp": [142, 144], "z_tmp": [142, 144], "comp_x": 142, "comp_i": 142, "comp_z": 142, "cont_chf": 142, "cont_ch2": 142, "cont_ful": 142, "ychf": 142, "ych2": 142, "yfull": 142, "yrest": 142, "monolay": 142, "adc_freq": 142, "skip": [142, 144, 156], "prefactor": 142, "adc_sx": 142, "adc_si": 142, "adc_sz": 142, "tmp_tm": 142, "pertient": 143, "koopman": [143, 146], "water_fluorine_xyz": 143, "gs_result": 143, "scf_ion": [143, 144, 145, 148], "ion_result": 143, "molecule_f": 143, "basis_f": 143, "scf_f": 143, "f_result": 143, "get_rho": 143, "mo1": 143, "mo2": 143, "mo3": 143, "rho3": 143, "az": 143, "mo1_g": 143, "mo1_ion": 143, "mo1_z1": 143, "1a_1": 143, "mo2_g": 143, "mo2_ion": 143, "mo2_z1": 143, "2a_1": 143, "mo2b_g": 143, "mo2b_ion": 143, "mo2b_z1": 143, "alpha_2": [143, 144], "alpha_1": [143, 144], "beta_2": 143, "decontract": [143, 149], "newli": 143, "balanc": [143, 144, 149], "methane_mol_str": 143, "6265918120": 143, "ammonia_mol_str": 143, "1175868000": 143, "9323800000": 143, "2743692000": 143, "4661900000": 143, "8074647660": 143, "hydrofluoride_mol_str": 143, "8261856000": 143, "0917984000": 143, "neon_mol_str": 143, "koopman_vs_delta": 143, "basis_label": [143, 153], "err_koopman": 143, "err_delta": 143, "expt": 143, "e_koopman": 143, "e_delta": 143, "405": [143, 144], "539": [143, 144], "694": 143, "870": 143, "5p": 143, "4937111288": 143, "176641252708": 143, "198632549790": 143, "07238664": 143, "00936881": 143, "199216137990": 143, "0005835882": 143, "00782091": 143, "00076076": 143, "02494254": 143, "199223311012": 143, "0000071730": 143, "00284629": 143, "00029267": 143, "00277747": 143, "199224544997": 143, "0000012340": 143, "00033787": 143, "00004920": 143, "00101091": 143, "199224580340": 143, "0000000353": 143, "00002279": 143, "00032567": 143, "199224580473": 143, "00000241": 143, "00000058": 143, "00002005": 143, "199224580475": 143, "00000024": 143, "1992245805": 143, "6929357092": 143, "0000002419": 143, "21468": 143, "94394": 143, "54399": 143, "19200": 143, "27467": 143, "58864": 143, "vlx_20240321_fe4b088f": 143, "984548233126": 143, "72929056": 143, "75211056": 143, "383245222949": 143, "3986969898": 143, "03746343": 143, "14598216": 143, "84846701": 143, "480740305899": 143, "0974950829": 143, "17120996": 143, "02756281": 143, "34603159": 143, "484157355961": 143, "0034170501": 143, "03303526": 143, "00415502": 143, "06446845": 143, "484720018471": 143, "0005626625": 143, "01405409": 143, "00136720": 143, "02807396": 143, "484843881109": 143, "0001238626": 143, "00254185": 143, "00035196": 143, "01842700": 143, "484845836451": 143, "0000019553": 143, "00046743": 143, "00007033": 143, "00338992": 143, "484845893262": 143, "0000000568": 143, "00008456": 143, "00000995": 143, "00035811": 143, "484845895285": 143, "0000000020": 143, "00001190": 143, "00000137": 143, "00007186": 143, "484845895330": 143, "00000170": 143, "00000025": 143, "00001234": 143, "00000111": 143, "4848458953": 143, "9785570241": 143, "0000001275": 143, "7756": 143, "84796": 143, "45098": 143, "99657": 143, "09031": 143, "02311": 143, "27795": 143, "36903": 143, "96052": 143, "19964": 143, "07555": 143, "01250": 143, "9703270415": 143, "154702188708": 143, "195358785586": 143, "09236701": 143, "01092262": 143, "196206735531": 143, "0008479499": 143, "01551902": 143, "00289180": 143, "03204290": 143, "196232682551": 143, "0000259470": 143, "00329250": 143, "00061368": 143, "00416037": 143, "196236230580": 143, "0000035480": 143, "00129802": 143, "00014764": 143, "00241244": 143, "196236654350": 143, "0000004238": 143, "00047049": 143, "00009292": 143, "00079374": 143, "196236728370": 143, "0000000740": 143, "00006997": 143, "00001054": 143, "00047731": 143, "196236729650": 143, "00000421": 143, "00000053": 143, "00006073": 143, "196236729653": 143, "00000048": 143, "00000255": 143, "1962367297": 143, "1665637711": 143, "0000004806": 143, "53583": 143, "13384": 143, "61616": 143, "42176": 143, "18607": 143, "27050": 143, "72999": 143, "vlx_20240321_699b5ee5": 143, "660410101572": 143, "36296681": 143, "93787381": 143, "122191658113": 143, "4617815565": 143, "36758506": 143, "19392095": 143, "86529171": 143, "266669310780": 143, "1444776527": 143, "21528914": 143, "02793667": 143, "35551128": 143, "271020414677": 143, "0043511039": 143, "03449561": 143, "00531354": 143, "06580037": 143, "271483608593": 143, "0004631939": 143, "01412355": 143, "00223336": 143, "02171266": 143, "271579300234": 143, "0000956916": 143, "00321463": 143, "00044586": 143, "01358060": 143, "271582780015": 143, "0000034798": 143, "00076046": 143, "00010369": 143, "00252762": 143, "271582946469": 143, "0000001665": 143, "00015419": 143, "00002015": 143, "00053815": 143, "271582952575": 143, "0000000061": 143, "00003472": 143, "00000430": 143, "00011550": 143, "271582952900": 143, "00000726": 143, "00000138": 143, "00002156": 143, "271582952917": 143, "00000201": 143, "00000041": 143, "00000518": 143, "271582952918": 143, "00000036": 143, "2715829529": 143, "2419099944": 143, "0000003577": 143, "7708": 143, "57272": 143, "71997": 143, "14527": 143, "13072": 143, "05496": 143, "38300": 143, "62136": 143, "09628": 143, "93070": 143, "30674": 143, "11641": 143, "04172": 143, "37116": 143, "980954854746": 143, "025912394461": 143, "10613691": 143, "01096404": 143, "026931952439": 143, "0010195580": 143, "02019241": 143, "00280757": 143, "02550308": 143, "026976262238": 143, "0000443098": 143, "00419173": 143, "00085956": 143, "00453733": 143, "026979226222": 143, "0000029640": 143, "00218984": 143, "00030105": 143, "00163383": 143, "026979655187": 143, "0000004290": 143, "00033786": 143, "00007031": 143, "00046129": 143, "026979678134": 143, "0000000229": 143, "00003955": 143, "00000573": 143, "00016589": 143, "026979678489": 143, "00000246": 143, "00002137": 143, "026979678490": 143, "00000049": 143, "0269796785": 143, "1831243979": 143, "0000004877": 143, "55028": 143, "33471": 143, "69724": 143, "56644": 143, "49324": 143, "18437": 143, "25556": 143, "78577": 143, "84995": 143, "16230": 143, "vlx_20240321_1c9dbfed": 143, "476698768014": 143, "00725477": 143, "00603661": 143, "031465126004": 143, "5547663580": 143, "49516221": 143, "19142953": 143, "85523582": 143, "177378495754": 143, "1459133698": 143, "20617595": 143, "03128268": 143, "33481131": 143, "180651358574": 143, "0032728628": 143, "03175806": 143, "00523624": 143, "05436888": 143, "180957941862": 143, "0003065833": 143, "01110568": 143, "00195632": 143, "01691272": 143, "181002534103": 143, "0000445922": 143, "00267353": 143, "00047453": 143, "00810046": 143, "181004700115": 143, "0000021660": 143, "00061110": 143, "00007448": 143, "00172878": 143, "181004792916": 143, "0000000928": 143, "00009944": 143, "00001508": 143, "00036532": 143, "181004794731": 143, "0000000018": 143, "00001782": 143, "00000370": 143, "00005401": 143, "181004794796": 143, "00000300": 143, "00000068": 143, "00000901": 143, "181004794798": 143, "00000011": 143, "00000154": 143, "1810047948": 143, "3371495142": 143, "0000007610": 143, "7648": 143, "02738": 143, "32957": 143, "23386": 143, "18294": 143, "17239": 143, "10078": 143, "37249": 143, "39727": 143, "59798": 143, "90790": 143, "26787": 143, "15789": 143, "10427": 143, "14601": 143, "15857": 143, "08775": 143, "36931": 143, "40896": 143, "1881022960": 143, "988874777753": 143, "018768000115": 143, "09773637": 143, "01303368": 143, "019585862254": 143, "0008178621": 143, "02190606": 143, "00305029": 143, "02171836": 143, "019640824607": 143, "0000549624": 143, "00566262": 143, "00116714": 143, "00487750": 143, "019645492095": 143, "0000046675": 143, "00331753": 143, "00040416": 143, "00201343": 143, "019646381262": 143, "0000008892": 143, "00037277": 143, "00005411": 143, "00064692": 143, "019646410026": 143, "0000000288": 143, "00003872": 143, "00000711": 143, "00017580": 143, "019646410326": 143, "00000210": 143, "00001858": 143, "019646410327": 143, "00000019": 143, "00000071": 143, "0196464103": 143, "2077487064": 143, "0000001942": 143, "27716": 143, "58313": 143, "74719": 143, "62915": 143, "18337": 143, "80873": 143, "40908": 143, "41388": 143, "vlx_20240321_e659e5d5": 143, "742490771103": 143, "65394692": 143, "19371628": 143, "398937627258": 143, "6564468562": 143, "45174136": 143, "15266049": 143, "80606973": 143, "507809858140": 143, "1088722309": 143, "15003366": 143, "02152883": 143, "27290087": 143, "509195127826": 143, "0013852697": 143, "02481321": 143, "00345443": 143, "03446813": 143, "509328657671": 143, "0001335298": 143, "00650857": 143, "00110570": 143, "01088816": 143, "509339136024": 143, "0000104784": 143, "00159980": 143, "00028573": 143, "00336728": 143, "509339787444": 143, "0000006514": 143, "00032453": 143, "00004058": 143, "00089691": 143, "509339810128": 143, "0000000227": 143, "00004148": 143, "00000612": 143, "00018196": 143, "509339810308": 143, "00000481": 143, "00001225": 143, "509339810311": 143, "00000052": 143, "00000206": 143, "5093398103": 143, "6974421063": 143, "0000005166": 143, "7589": 143, "25722": 143, "41524": 143, "54540": 143, "46185": 143, "21792": 143, "30737": 143, "73464": 143, "84884": 143, "28147": 143, "46527": 143, "37679": 143, "76185": 143, "20513": 143, "31497": 143, "77758": 143, "488925926667": 143, "488925929027": 143, "00008363": 143, "00002132": 143, "488925929352": 143, "00001743": 143, "00000273": 143, "00001389": 143, "488925929371": 143, "00000043": 143, "00000014": [143, 148], "00000294": 143, "4889259294": 143, "0000004282": 143, "76419": 143, "91886": 143, "83240": 143, "69054": 143, "09313": 143, "19630": 143, "vlx_20240321_16a2e6a2": 143, "724739415048": 143, "28148132": 143, "26602289": 143, "447251770784": 143, "7225123557": 143, "28775994": 143, "20942739": 143, "73277939": 143, "508840201458": 143, "0615884307": 143, "08798008": 143, "01988639": 143, "19104619": 143, "509196421834": 143, "0003562204": 143, "01626179": 143, "00327620": 143, "01701992": 143, "509231483788": 143, "0000350620": 143, "00285999": 143, "00052555": 143, "00566536": 143, "509232485076": 143, "0000010013": 143, "00010250": 143, "00003847": 143, "00110714": 143, "509232486360": 143, "00001338": 143, "00000395": 143, "00004150": 143, "509232486370": 143, "00000063": 143, "00000278": 143, "5092324864": 143, "0000006335": 143, "7549": 143, "33903": 143, "94250": 143, "86722": 143, "89666": 143, "25223": 143, "43099": 143, "79165": 143, "77472": 143, "22975": 143, "94282": 143, "35039": 143, "ro": 143, "zorder": 143, "wrt": 143, "mole": [143, 144, 145, 148], "unc": 143, "xas_adc1": 143, "cvs_adc1": 143, "n_singlet": [143, 144], "xas_adc2": 143, "cvs_adc2": [143, 144, 148], "xas_adc2x": 143, "cvs_adc2x": 143, "xas_adc3": 143, "cvs_adc3": 143, "mo0": [143, 144, 145, 148], "occ0": [143, 144, 145, 148], "alpha_0": [143, 145], "addon": [143, 144, 145, 148], "mom_occ": [143, 144, 145, 148], "xes_adc1": 143, "xes_adc2": 143, "xes_adc2x": 143, "xes_adc3": 143, "534": [143, 148], "bo": 143, "527": [143, 156], "influenti": [143, 144], "greatli": 143, "l_1": 143, "pv": 143, "pcv": 143, "u6": [143, 149], "un6": 143, "toggl": 143, "u6311gss": 143, "pars": 143, "8588": 143, "1297": [143, 156], "230": 143, "2960": [143, 156], "37710": 143, "67890": 143, "740040": 143, "sp": 143, "11750": 143, "113889": 143, "0365114": 143, "628370": 143, "920811": 143, "237153": 143, "853320": 143, "00327447": 143, "819702": 143, "905661": 143, "255611": 143, "292": 143, "un6311gss": 143, "z6311gss": 143, "00189515": 143, "0143859": 143, "0707320": 143, "2400010": 143, "5947970": 143, "2808020": 143, "11427": 143, "00180093": 143, "1722": 143, "350": 143, "0137419": 143, "0681334": 143, "1390": [143, 156], "2333250": 143, "60260": 143, "5890860": 143, "919010": 143, "2995050": 143, "44410": 143, "114536": 143, "0354609": 143, "63230": 143, "920512": 143, "237451": 143, "717560": 143, "00337804": 143, "820458": 143, "165450": 143, "321892": 143, "750": 143, "ip_hf": 143, "ip_mp2": 143, "ip_ccsd": 143, "ip_b3lyp": 143, "scfre": 143, "delta_hf": 143, "scfion": 143, "energy_tot": [143, 145], "delta_ccsd": 143, "ccsd_re": 143, "uccsd": 143, "ccsd_ion": 143, "max_cycl": 143, "delta_mp2": 143, "emp2": 143, "uk": 143, "delta_dft": 143, "bv": 143, "orang": 143, "tick": 143, "fortuit": 143, "nonloc": 143, "hf_exc": 143, "hf_blyp": 143, "hf_pbe": 143, "dft_delta": 143, "dft_re": 143, "dft_ion": [143, 144], "h_x": 143, "bxlyp": 143, "s_x": 143, "b_x": 143, "v_l": 143, "e_mo": 143, "pbex": 143, "508": 143, "562": 143, "acheiev": 143, "unproblemat": 143, "ethene_mol_str": 143, "c0": 143, "6660048050": 143, "2278735620": 143, "9228358077": 143, "ecp": [143, 144, 147], "delta_al": 143, "delta_ecp": 143, "stuttgart": 143, "localizatio": 143, "stex": 143, "dual": 143, "worth": 143, "ethene_adc1_0": 143, "ethene_adc1_1": 143, "ethene_adc1_01": 143, "ethene_adc2_0": 143, "ethene_adc2_1": 143, "ethene_adc2_01": 143, "vinyl_adc1_1": 143, "vinyl_adc1_2": 143, "vinyl_adc1_12": 143, "vinyl_adc2_1": 143, "vinyl_adc2_2": 143, "vinyl_adc2_12": 143, "immediatelli": 143, "shot": 143, "problemat": 143, "ammonia": 143, "flavour": [143, 144], "mocktask": 144, "mpi_comm": 144, "559": [144, 145], "cycl": 144, "o_": 144, "p_j": 144, "imom": 144, "unstabl": 144, "aufbau": [144, 148], "corrupt": 144, "mol_ion": 144, "scf_ion_result": 144, "hf_ie": 144, "mp2_g": 144, "mp2_ion": 144, "mp2_ie": 144, "ump2": 144, "dft_g": 144, "dft_ion_result": 144, "dft_ie": 144, "upward": [144, 148], "relav": 144, "ethyl": 144, "trifluoroacet": 144, "esca": 144, "esca_xyz": 144, "1183780041": 144, "3449927563": 144, "0140172822": 144, "2599020293": 144, "9430366372": 144, "0248385056": 144, "4019839124": 144, "0408200726": 144, "0368443870": 144, "8399255955": 144, "1560630574": 144, "0169777359": 144, "8945563482": 144, "0267696528": 144, "1485539196": 144, "7954196415": 144, "0187110930": 144, "0011424145": 144, "0675509573": 144, "8144007049": 144, "0614767265": 144, "7486063992": 144, "4602333713": 144, "1739210991": 144, "1986940727": 144, "1850294900": 144, "1302033614": 144, "3268717284": 144, "1720377773": 144, "5289059043": 144, "6185520565": 144, "8344576449": 144, "1859838788": 144, "3116641442": 144, "1959612359": 144, "1419001202": 144, "7716619472": 144, "1057672384": 144, "0380096706": 144, "6012985602": 144, "5468300237": 144, "5651778685": 144, "esca_i": 144, "302": 144, "295": 144, "293": 144, "277": 144, "arb": 144, "photoabsorpt": 144, "disctinct": 144, "xane": 144, "exaf": 144, "interfer": [144, 149], "condens": 144, "atttenu": 144, "xaf": 144, "remaind": 144, "circumv": 144, "spuriou": 144, "valen": 144, "abot": 144, "533": 144, "543": 144, "71638": [144, 145], "5099": [144, 145], "7967": [144, 145], "6956": [144, 145], "0373": [144, 145, 156], "8087": [144, 145], "49351": [144, 145], "557": [144, 145], "6567": [144, 145], "0099": [144, 145, 156], "7858": [144, 145, 156], "2142": [144, 145, 156], "50482": [144, 145], "9647": [144, 145], "8441": [144, 145], "1559": [144, 145, 156], "rpa_drv": 144, "tdaeigensolv": 144, "decid": 144, "rough": 144, "514": 144, "520": [144, 148], "erron": 144, "mcscf_cpp": 144, "mclr_cppsolver": 144, "set_damp": 144, "set_frequency_rang": 144, "step_siz": 144, "produce_plot": 144, "auger": 144, "biolog": 144, "heavier": [144, 149], "channel": 144, "vtc": 144, "weakest": 144, "mock": 144, "adc_x": [144, 145, 148], "598": 144, "603": 144, "20632": 144, "2647": 144, "9644": 144, "03563": 144, "15933": 144, "9622": 144, "03785": 144, "09183": 144, "1495": [144, 156], "1612": 144, "9588": 144, "04123": 144, "04624": 144, "599": 144, "9086": 144, "1409": [144, 156], "9561": 144, "04391": 144, "disagr": 144, "epsilon_v": [144, 146], "multichannel": 144, "massiv": 144, "n_core": 144, "energy_diff": 144, "mo_c": 144, "y_ao": 144, "y_mo": 144, "z_ao": 144, "z_mo": 144, "65707757": 144, "6878829": 144, "39950787": 144, "70379307": 144, "94953867": 144, "01478": 144, "258": 144, "00238": 144, "04878": 144, "510": 144, "00255": 144, "05050": 144, "708": 144, "00342": 144, "05848": 144, "impress": 144, "disregard": 144, "detun": 144, "trickier": 144, "adc_rx": 144, "adc_rix": 144, "indx": 144, "e_xa": 144, "i_xa": 144, "i_x": 144, "specta": 144, "marker": 144, "tmp": 144, "ok": 144, "markers": [144, 156], "10000": 144, "530": 144, "tdscf": 145, "mp_re": 145, "mp_ion": 145, "ionzat": 145, "scf_re": [145, 148], "similarl": 146, "c2h2f2": 146, "3836545197": 146, "0624718520": 146, "9374006976": 146, "9085904157": 146, "0780878284": 146, "6951077256": 146, "6941077256": 146, "closest": 146, "psi_v": 146, "mayb": 147, "tricki": 147, "Be": 148, "pump": 148, "muliticipl": 148, "lsor": 148, "hsor": 148, "claim": 148, "scf_lsor": 148, "scf_hsor": 148, "adc_g": 148, "adc_lsor": 148, "adc_hsor": 148, "ground_stat": 148, "somo": 148, "40792": 148, "983870205311": 148, "384872592259": 148, "05814060": 148, "01079184": 148, "384686594376": 148, "0001859979": 148, "07420221": 148, "01375784": 148, "03127402": 148, "385180742153": 148, "0004941478": 148, "00038519": 148, "00008834": 148, "01650959": 148, "385180774173": 148, "0000000320": 148, "00007657": 148, "00002027": 148, "00029092": 148, "385180774932": 148, "0000000008": 148, "00000194": 148, "00000051": 148, "00002929": 148, "385180774934": 148, "3851807749": 148, "5413254944": 148, "0000001389": 148, "13379": 148, "01751": 148, "52917": 148, "35661": 148, "29214": 148, "05639": 148, "14625": 148, "80982": 148, "87513": 148, "88918": 148, "11351025": 148, "09818089": 148, "18647630": 148, "09204895": 148, "84616908": 148, "02730824": 148, "11231928": 148, "01012702": 148, "18487023": 148, "84589976": 148, "51e": 148, "20e": 148, "11231840": 148, "00025135": 148, "036994": 148, "053332": 148, "026326": 148, "037908": 148, "054574": 148, "023365": 148, "116020": 148, "051026": 148, "07268": 148, "0174": [148, 153, 156], "522": 148, "04691": 148, "0364": [148, 156], "03444": 148, "0092": [148, 156], "core_1": 148, "9993": 148, "9984": 148, "9986": 148, "useless": 148, "presuppos": 148, "That": 148, "tediou": 148, "xes_rev_": 148, "xes_rev_f": 148, "xes_": 148, "xes_f": 148, "struggl": 149, "argu": 149, "practis": 149, "multilay": 149, "poorer": 149, "intensitit": 149, "src2": 149, "r1": 149, "descipt": 149, "anywai": 149, "x2c": 149, "dougla": 149, "kroll": 149, "notori": 149, "cast": 150, "longrightarrow": 150, "572": 150, "383": 150, "kg": 150, "987": 150, "772": 150, "359": 150, "744": [150, 156], "418": 150, "884": 150, "854": 150, "297": 150, "478": 150, "physical_const": 150, "wien": 150, "1st": 150, "polarizabl": 150, "magn": 150, "flux": 150, "deuteron": 150, "magneton": 150, "neutron": 150, "gyromagn": 150, "anomali": 150, "helion": 150, "muon": 150, "220": 150, "lattic": 150, "mev": 150, "star": 150, "hertz": 150, "meter": 150, "joul": 150, "kilogram": 150, "mag": 150, "hz": 150, "tesla": 150, "imped": 150, "compton": 150, "conduct": 150, "josephson": 150, "von": 150, "klitz": 150, "cu": 150, "gyromag": 150, "radianc": 150, "loschmidt": 150, "273": 150, "kpa": 150, "gravit": 150, "mhz": 150, "fm": 150, "gev": 150, "circul": 150, "hc": 150, "sackur": 150, "tetrod": 150, "graviti": 150, "atmospher": 150, "stefan": 150, "thomson": 150, "triton": 150, "unifi": 150, "um": 150, "amper": 150, "farad": 150, "henri": 150, "ohm": 150, "watt": 150, "hyperfin": 150, "lumin": 150, "efficaci": 150, "hd": 150, "ht": 150, "uncertainti": 150, "054571817e": 150, "602176634e": 150, "1093837015e": 150, "29177210903e": 150, "3597447222071e": 150, "4188843265857e": 150, "au2j": 150, "calori": 150, "au2cm": 150, "au2nm": 150, "0e9": 150, "au2kjmol": 150, "au2kcalmol": 150, "21139": 150, "219474": 150, "56335": 150, "2625": [150, 156], "5095": 150, "contact": 150, "occasion": 150, "breviti": 150, "2113245": 151, "doppler": 151, "homogen": 151, "gamma_k": 151, "ln": 151, "conclus": 153, "1187290000": 153, "7532010000": 153, "4749160000": 153, "adc_stat": 153, "3054352": 153, "311314": 153, "0142": [153, 156], "04089": 153, "3903211": 153, "62118": 153, "9636": 153, "03637": 153, "691": 153, "0451": [153, 156], "0227": [153, 156], "0306": [153, 156], "0253": [153, 156], "0182": [153, 156], "0107": [153, 156], "0598": [153, 156], "0301": [153, 156], "0234": [153, 156], "centroid": 153, "1ddm": 153, "rho_f": 153, "p_state": 153, "state_diffdm": 153, "to_ao_basi": 153, "p_state_ao": 153, "to_ndarrai": 153, "cubegen": 153, "outfil": 153, "water_detachment_": 153, "water_attachment_": 153, "voronoi": 153, "tetrafluoroethen": 153, "tfe": 153, "c2h4_xyz": 153, "6655087212": 153, "2112231877": 153, "9379948213": 153, "c2f4_str": 153, "6665934397": 153, "3499511337": 153, "1743643195": 153, "dist_str": 153, "dimer_4a": 153, "file_nam": [153, 154, 156], "unicod": 153, "x212b": 153, "dimer_10a": 153, "slider": [154, 156], "ipywidget": [154, 156], "read_pdb_fil": 154, "pdb_file": 154, "pdb_file_nam": 154, "bithiophen": 154, "pdb_data": 154, "read_pdb_index": 154, "current_index": [154, 156], "endmdl": 154, "return_view": [154, 156], "pdb_data_i": 154, "widget": [154, 156], "total_step": [154, 156], "intslid": [154, 156], "__main__": [154, 156], "movi": 155, "xyz_fil": 156, "xyz_file_nam": 156, "kahweol_optim": 156, "xyz_data": 156, "read_xyz_index": 156, "readlin": 156, "xyz_data_i": 156, "energy_i": 156, "xtb_hessian_drv": 156, "xtbhessiandriv": 156, "kahweol_xtb_hessian": 156, "kahweol_hessian": 156, "kahweol_dipolegrad": 156, "subsect": 156, "mlecul": 156, "xtb_opt_kahweol": 156, "0057": 156, "mdyne": 156, "4671": 156, "0063": 156, "2048": 156, "2562": 156, "2333": 156, "0412": 156, "0481": 156, "0021": 156, "0344": 156, "0289": 156, "0616": 156, "0208": 156, "0510": 156, "0420": 156, "0461": 156, "0453": 156, "0309": 156, "0166": 156, "0615": 156, "0485": 156, "0058": 156, "0080": 156, "0764": 156, "0153": 156, "0333": 156, "0500": 156, "0074": 156, "0404": 156, "0439": 156, "0423": 156, "0029": 156, "0648": 156, "0230": 156, "0019": 156, "0034": 156, "0343": 156, "0218": 156, "0746": 156, "0215": 156, "0387": 156, "0238": 156, "0195": 156, "0408": 156, "1014": 156, "0422": 156, "0622": 156, "1515": 156, "0200": 156, "0270": 156, "0554": 156, "0061": 156, "0427": 156, "0374": 156, "0607": 156, "0395": 156, "0394": 156, "0491": 156, "0357": 156, "0483": 156, "0015": 156, "0314": 156, "0938": 156, "0180": 156, "0335": 156, "0496": 156, "0095": 156, "0474": 156, "0288": 156, "0538": 156, "0091": 156, "0081": 156, "0318": 156, "0657": 156, "0127": 156, "0680": 156, "0591": 156, "0653": 156, "0704": 156, "0355": 156, "0310": 156, "0577": 156, "2599": 156, "1413": 156, "1615": 156, "0963": 156, "1244": 156, "2222": 156, "0257": 156, "1171": 156, "0313": 156, "0642": 156, "0275": 156, "0468": 156, "0459": 156, "1247": 156, "0690": 156, "3611": 156, "4350": 156, "0557": 156, "0872": 156, "2202": 156, "0821": 156, "2169": 156, "0791": 156, "1585": 156, "2385": 156, "0114": 156, "0385": 156, "1321": 156, "0025": 156, "0478": 156, "0750": 156, "0400": 156, "0745": 156, "0658": 156, "0388": 156, "0290": 156, "0303": 156, "0260": 156, "0800": 156, "0066": 156, "0375": 156, "0454": 156, "0225": 156, "0455": 156, "1243": 156, "0371": 156, "0531": 156, "0353": 156, "0023": 156, "0645": 156, "0049": 156, "1062": 156, "0273": 156, "0822": 156, "0788": 156, "0497": 156, "0096": 156, "0952": 156, "0329": 156, "0621": 156, "1252": 156, "0580": 156, "0294": 156, "1948": 156, "0044": 156, "0488": 156, "0756": 156, "1058": 156, "0399": 156, "0418": 156, "0950": 156, "0098": 156, "0772": 156, "0614": 156, "0526": 156, "0669": 156, "1319": 156, "0694": 156, "0865": 156, "0417": 156, "1622": 156, "0162": 156, "0204": 156, "0941": 156, "1181": 156, "0226": 156, "0327": 156, "0814": 156, "0457": 156, "1076": 156, "0390": 156, "1172": 156, "0629": 156, "0913": 156, "0097": 156, "0207": 156, "0586": 156, "0285": 156, "0716": 156, "1040": 156, "1865": 156, "0150": 156, "1425": 156, "1184": 156, "0246": 156, "1163": 156, "0816": 156, "0542": 156, "0574": 156, "0958": 156, "0087": 156, "1535": 156, "0323": 156, "3299": 156, "0847": 156, "0322": 156, "2865": 156, "6277": 156, "3427": 156, "0917": 156, "0902": 156, "0476": 156, "0262": 156, "1117": 156, "0282": 156, "0347": 156, "0161": 156, "0664": 156, "0569": 156, "0085": 156, "0088": 156, "0084": 156, "0171": 156, "0317": 156, "0075": 156, "0383": 156, "0177": 156, "0368": 156, "0823": 156, "1463": 156, "0086": 156, "0452": 156, "0345": 156, "0986": 156, "1293": 156, "0449": 156, "0935": 156, "0037": 156, "0071": 156, "0299": 156, "1408": 156, "0168": 156, "0683": 156, "1121": 156, "1004": 156, "0961": 156, "0626": 156, "0027": 156, "1033": 156, "0493": 156, "1597": 156, "0998": 156, "0434": 156, "0093": 156, "0447": 156, "0446": 156, "0205": 156, "0392": 156, "1519": 156, "0401": 156, "0563": 156, "1382": 156, "1077": 156, "1741": 156, "1354": 156, "0904": 156, "0467": 156, "2345": 156, "0324": 156, "0089": 156, "0665": 156, "0926": 156, "0495": 156, "1302": 156, "0473": 156, "0365": 156, "0425": 156, "2353": 156, "2530": 156, "0761": 156, "1112": 156, "1529": 156, "2102": 156, "1219": 156, "1378": 156, "1233": 156, "0828": 156, "0578": 156, "1978": 156, "2828": 156, "1578": 156, "4742": 156, "0228": 156, "5238": 156, "0844": 156, "0188": 156, "0316": 156, "1284": 156, "0751": 156, "1712": 156, "0045": 156, "0403": 156, "0337": 156, "0539": 156, "0320": 156, "0528": 156, "0555": 156, "0020": 156, "0120": 156, "0201": 156, "0757": 156, "0494": 156, "0433": 156, "0181": 156, "1242": 156, "0547": 156, "1254": 156, "0073": 156, "1492": 156, "0480": 156, "0305": 156, "0039": 156, "0128": 156, "0035": 156, "0987": 156, "1218": 156, "0280": 156, "0509": 156, "0874": 156, "1452": 156, "0402": 156, "0276": 156, "0210": 156, "0428": 156, "0637": 156, "0967": 156, "0520": 156, "0416": 156, "0471": 156, "0279": 156, "0482": 156, "1765": 156, "0636": 156, "1149": 156, "1876": 156, "1123": 156, "0714": 156, "0231": 156, "0826": 156, "0047": 156, "0604": 156, "0733": 156, "1271": 156, "0695": 156, "0631": 156, "0617": 156, "0079": 156, "1232": 156, "1605": 156, "0882": 156, "0308": 156, "0131": 156, "0916": 156, "2441": 156, "0372": 156, "1340": 156, "2320": 156, "0936": 156, "1257": 156, "0046": 156, "0060": 156, "0639": 156, "1875": 156, "0338": 156, "0989": 156, "2829": 156, "0666": 156, "0297": 156, "4209": 156, "0561": 156, "0708": 156, "0248": 156, "0900": 156, "0469": 156, "0519": 156, "0579": 156, "0212": 156, "0693": 156, "0245": 156, "0272": 156, "0048": 156, "0211": 156, "1086": 156, "0927": 156, "0254": 156, "0090": 156, "0137": 156, "0911": 156, "0659": 156, "0332": 156, "0980": 156, "0646": 156, "0530": 156, "0880": 156, "1028": 156, "0536": 156, "0737": 156, "0799": 156, "0269": 156, "0856": 156, "0556": 156, "1541": 156, "0186": 156, "0787": 156, "0576": 156, "0156": 156, "0463": 156, "0592": 156, "0535": 156, "0263": 156, "0460": 156, "1556": 156, "0834": 156, "0438": 156, "2165": 156, "1914": 156, "0906": 156, "0752": 156, "1249": 156, "0030": 156, "0281": 156, "0611": 156, "0831": 156, "0776": 156, "0050": 156, "1816": 156, "0271": 156, "3007": 156, "1669": 156, "3511": 156, "2545": 156, "0362": 156, "2108": 156, "1327": 156, "0711": 156, "0739": 156, "0252": 156, "0862": 156, "1510": 156, "0172": 156, "0644": 156, "0026": 156, "6984": 156, "2810": 156, "0630": 156, "0379": 156, "0738": 156, "1196": 156, "0300": 156, "0854": 156, "0334": 156, "0221": 156, "0441": 156, "0879": 156, "0503": 156, "0929": 156, "0296": 156, "0760": 156, "1882": 156, "0487": 156, "0676": 156, "1043": 156, "0545": 156, "0078": 156, "0730": 156, "1202": 156, "1070": 156, "0562": 156, "0472": 156, "0470": 156, "0583": 156, "0328": 156, "0249": 156, "0589": 156, "1084": 156, "0809": 156, "0907": 156, "0429": 156, "1301": 156, "0370": 156, "0515": 156, "0672": 156, "2231": 156, "3585": 156, "1867": 156, "3231": 156, "1170": 156, "0770": 156, "0358": 156, "1718": 156, "0933": 156, "0516": 156, "0971": 156, "0352": 156, "1412": 156, "0928": 156, "2206": 156, "0891": 156, "1815": 156, "0304": 156, "162": 156, "1261": 156, "0643": 156, "1522": 156, "1683": 156, "1178": 156, "0663": 156, "1333": 156, "0154": 156, "0763": 156, "0887": 156, "0953": 156, "0522": 156, "0759": 156, "0255": 156, "0424": 156, "0445": 156, "0450": 156, "0748": 156, "0384": 156, "0393": 156, "1756": 156, "0534": 156, "0389": 156, "0572": 156, "0173": 156, "0667": 156, "0492": 156, "0326": 156, "0325": 156, "0062": 156, "0054": 156, "0396": 156, "0100": 156, "1225": 156, "0506": 156, "0331": 156, "0703": 156, "0804": 156, "1278": 156, "0782": 156, "0448": 156, "1008": 156, "1031": 156, "0366": 156, "3096": 156, "1127": 156, "1447": 156, "0342": 156, "0051": 156, "0567": 156, "1128": 156, "0662": 156, "1061": 156, "0846": 156, "1307": 156, "2121": 156, "0440": 156, "1156": 156, "0914": 156, "0974": 156, "1665": 156, "0559": 156, "1385": 156, "1324": 156, "0943": 156, "2201": 156, "0866": 156, "9823": 156, "6575": 156, "0069": 156, "0017": 156, "0223": 156, "0220": 156, "0340": 156, "0582": 156, "0312": 156, "0070": 156, "1134": 156, "0877": 156, "0381": 156, "1197": 156, "0546": 156, "0744": 156, "0283": 156, "0184": 156, "0845": 156, "0566": 156, "0302": 156, "0466": 156, "0723": 156, "0552": 156, "1024": 156, "0603": 156, "0585": 156, "1304": 156, "0558": 156, "1110": 156, "0236": 156, "0250": 156, "0349": 156, "4788": 156, "3545": 156, "2187": 156, "3941": 156, "0056": 156, "1435": 156, "2821": 156, "1205": 156, "0398": 156, "1339": 156, "0771": 156, "1530": 156, "7880": 156, "8579": 156, "0386": 156, "0924": 156, "0820": 156, "0600": 156, "0435": 156, "0006": 156, "0507": 156, "0267": 156, "0677": 156, "0479": 156, "0634": 156, "0618": 156, "0274": 156, "0064": 156, "0853": 156, "0350": 156, "0405": 156, "0169": 156, "0758": 156, "0406": 156, "0532": 156, "0059": 156, "0193": 156, "1032": 156, "0014": 156, "0923": 156, "0247": 156, "0883": 156, "0819": 156, "0475": 156, "1208": 156, "1311": 156, "0360": 156, "0807": 156, "0082": 156, "0010": 156, "1020": 156, "0548": 156, "3872": 156, "3424": 156, "2292": 156, "3259": 156, "1419": 156, "1731": 156, "2188": 156, "0348": 156, "0955": 156, "1246": 156, "1918": 156, "0315": 156, "1611": 156, "0217": 156, "1623": 156, "1331": 156, "6357": 156, "0920": 156, "1934": 156, "2644": 156, "0691": 156, "0224": 156, "0419": 156, "1027": 156, "0768": 156, "0094": 156, "0790": 156, "0251": 156, "0307": 156, "1097": 156, "0610": 156, "0999": 156, "0244": 156, "0141": 156, "1328": 156, "0786": 156, "0930": 156, "0413": 156, "0525": 156, "0937": 156, "2299": 156, "1773": 156, "1203": 156, "0052": 156, "1915": 156, "0729": 156, "0286": 156, "0850": 156, "0571": 156, "1050": 156, "3210": 156, "1963": 156, "3385": 156, "0486": 156, "2109": 156, "1801": 156, "2656": 156, "2477": 156, "7688": 156, "0321": 156, "0124": 156, "0235": 156, "0130": 156, "0160": 156, "0287": 156, "0110": 156, "0241": 156, "0145": 156, "0942": 156, "0940": 156, "0692": 156, "0774": 156, "0284": 156, "1102": 156, "5899": 156, "2695": 156, "4527": 156, "3196": 156, "1763": 156, "3724": 156, "5900": 156, "1095": 156, "1238": 156, "0077": 156, "0295": 156, "0529": 156, "0504": 156, "0594": 156, "0356": 156, "0502": 156, "1668": 156, "0511": 156, "0550": 156, "1291": 156, "1096": 156, "1049": 156, "0995": 156, "0560": 156, "0619": 156, "0718": 156, "1093": 156, "0895": 156, "1107": 156, "1056": 156, "0717": 156, "1092": 156, "1616": 156, "2570": 156, "1560": 156, "3884": 156, "2519": 156, "1750": 156, "2137": 156, "3303": 156, "1433": 156, "0319": 156, "1719": 156, "0962": 156, "0863": 156, "0727": 156, "0829": 156, "0652": 156, "1347": 156, "271": 156, "8846": 156, "8985": 156, "0523": 156, "0851": 156, "0985": 156, "0827": 156, "0498": 156, "0292": 156, "1223": 156, "0219": 156, "1273": 156, "0240": 156, "1154": 156, "0613": 156, "1015": 156, "1735": 156, "0993": 156, "1351": 156, "1207": 156, "1652": 156, "3336": 156, "3128": 156, "0860": 156, "0041": 156, "1349": 156, "1194": 156, "1905": 156, "1179": 156, "1690": 156, "1313": 156, "1276": 156, "1549": 156, "2678": 156, "0533": 156, "8600": 156, "2975": 156, "0415": 156, "0158": 156, "0762": 156, "0410": 156, "0277": 156, "1099": 156, "1724": 156, "1122": 156, "0881": 156, "1053": 156, "1513": 156, "2375": 156, "0775": 156, "1080": 156, "1268": 156, "1475": 156, "0910": 156, "1384": 156, "2660": 156, "1399": 156, "3832": 156, "1637": 156, "1074": 156, "1306": 156, "1847": 156, "0743": 156, "1591": 156, "0701": 156, "0755": 156, "294": 156, "1303": 156, "1600": 156, "0391": 156, "1090": 156, "1446": 156, "0869": 156, "1126": 156, "0040": 156, "0713": 156, "1438": 156, "0330": 156, "1078": 156, "0584": 156, "0996": 156, "2168": 156, "1526": 156, "0684": 156, "0608": 156, "0612": 156, "3182": 156, "1786": 156, "3484": 156, "1217": 156, "1674": 156, "0939": 156, "2420": 156, "1155": 156, "2909": 156, "1734": 156, "1593": 156, "301": 156, "9885": 156, "1603": 156, "0426": 156, "1025": 156, "2216": 156, "0957": 156, "0725": 156, "0908": 156, "0660": 156, "0638": 156, "0901": 156, "1517": 156, "1656": 156, "1350": 156, "0499": 156, "2367": 156, "1133": 156, "1662": 156, "1947": 156, "4000": 156, "1595": 156, "1388": 156, "2117": 156, "1684": 156, "1259": 156, "1429": 156, "319": 156, "1543": 156, "4964": 156, "0136": 156, "1037": 156, "0732": 156, "2135": 156, "0602": 156, "0721": 156, "0697": 156, "0670": 156, "1279": 156, "2093": 156, "1407": 156, "1764": 156, "1290": 156, "0888": 156, "1866": 156, "0778": 156, "0581": 156, "1472": 156, "4060": 156, "1645": 156, "2664": 156, "1323": 156, "0687": 156, "0975": 156, "2243": 156, "2970": 156, "333": 156, "4191": 156, "1584": 156, "8184": 156, "0490": 156, "0517": 156, "0378": 156, "1554": 156, "1383": 156, "0565": 156, "1370": 156, "0773": 156, "3317": 156, "2572": 156, "1023": 156, "2593": 156, "1827": 156, "0728": 156, "2991": 156, "0696": 156, "0789": 156, "1269": 156, "0432": 156, "1514": 156, "0298": 156, "1627": 156, "2148": 156, "0959": 156, "1048": 156, "1255": 156, "1753": 156, "1344": 156, "0979": 156, "357": 156, "8193": 156, "2118": 156, "5148": 156, "0840": 156, "0903": 156, "0668": 156, "0361": 156, "1135": 156, "0553": 156, "0966": 156, "0754": 156, "1111": 156, "0380": 156, "1728": 156, "1811": 156, "1787": 156, "1975": 156, "1736": 156, "0421": 156, "3394": 156, "3037": 156, "1411": 156, "1282": 156, "0797": 156, "1572": 156, "2189": 156, "1164": 156, "1286": 156, "2066": 156, "1294": 156, "0813": 156, "1531": 156, "1289": 156, "0783": 156, "0359": 156, "0661": 156, "0264": 156, "367": 156, "3828": 156, "1199": 156, "1746": 156, "0508": 156, "1227": 156, "0802": 156, "0540": 156, "0068": 156, "1216": 156, "1691": 156, "0875": 156, "0568": 156, "2308": 156, "1485": 156, "1193": 156, "1089": 156, "1455": 156, "2327": 156, "2293": 156, "1045": 156, "0885": 156, "1523": 156, "0899": 156, "1410": 156, "2076": 156, "1667": 156, "1081": 156, "1808": 156, "1509": 156, "3421": 156, "4508": 156, "1369": 156, "0570": 156, "0265": 156, "2030": 156, "1310": 156, "1487": 156, "2097": 156, "2355": 156, "1153": 156, "0649": 156, "2753": 156, "0651": 156, "2711": 156, "1777": 156, "2265": 156, "0724": 156, "7142": 156, "4773": 156, "1343": 156, "0599": 156, "0512": 156, "1391": 156, "3677": 156, "1204": 156, "2897": 156, "3020": 156, "0982": 156, "1330": 156, "3690": 156, "0988": 156, "0769": 156, "0960": 156, "1348": 156, "1298": 156, "416": 156, "9117": 156, "4005": 156, "4654": 156, "1617": 156, "0719": 156, "0377": 156, "0671": 156, "0376": 156, "1066": 156, "0012": 156, "1285": 156, "1635": 156, "1320": 156, "0884": 156, "1106": 156, "3551": 156, "1168": 156, "1896": 156, "1145": 156, "2630": 156, "0859": 156, "1088": 156, "0981": 156, "0605": 156, "1952": 156, "1332": 156, "0835": 156, "0458": 156, "0686": 156, "0674": 156, "1251": 156, "0590": 156, "1483": 156, "1524": 156, "2144": 156, "0951": 156, "0736": 156, "0430": 156, "0896": 156, "434": 156, "4452": 156, "2715": 156, "8699": 156, "0702": 156, "0185": 156, "0931": 156, "1870": 156, "1749": 156, "1228": 156, "1006": 156, "0753": 156, "1682": 156, "2055": 156, "1147": 156, "0973": 156, "1010": 156, "1778": 156, "0994": 156, "3641": 156, "447": 156, "5920": 156, "3056": 156, "5629": 156, "0984": 156, "0735": 156, "3579": 156, "1834": 156, "2323": 156, "0803": 156, "1260": 156, "2548": 156, "0722": 156, "1695": 156, "0336": 156, "1359": 156, "0810": 156, "3326": 156, "1428": 156, "1069": 156, "0842": 156, "0836": 156, "1392": 156, "2479": 156, "5590": 156, "3112": 156, "2901": 156, "0792": 156, "0544": 156, "0537": 156, "0409": 156, "0841": 156, "1085": 156, "1059": 156, "0894": 156, "2159": 156, "0838": 156, "1739": 156, "1214": 156, "1114": 156, "1368": 156, "1545": 156, "0706": 156, "0886": 156, "3199": 156, "2958": 156, "1702": 156, "475": 156, "4137": 156, "1883": 156, "0587": 156, "0521": 156, "3607": 156, "2134": 156, "4165": 156, "2321": 156, "5989": 156, "4980": 156, "1177": 156, "1404": 156, "0734": 156, "0817": 156, "1221": 156, "1030": 156, "0991": 156, "1767": 156, "1943": 156, "1042": 156, "1336": 156, "1486": 156, "2034": 156, "1807": 156, "2115": 156, "1420": 156, "1533": 156, "2500": 156, "3464": 156, "1570": 156, "0632": 156, "1140": 156, "1220": 156, "523": 156, "4464": 156, "5574": 156, "6264": 156, "0700": 156, "0849": 156, "1468": 156, "0767": 156, "1467": 156, "0444": 156, "1521": 156, "0867": 156, "1005": 156, "3130": 156, "1459": 156, "1869": 156, "0673": 156, "1482": 156, "2552": 156, "0781": 156, "3561": 156, "8354": 156, "9724": 156, "0970": 156, "0815": 156, "1256": 156, "0912": 156, "0839": 156, "2516": 156, "1372": 156, "1104": 156, "1241": 156, "1396": 156, "1120": 156, "2306": 156, "1192": 156, "1707": 156, "1432": 156, "1423": 156, "2322": 156, "1537": 156, "561": 156, "3221": 156, "6160": 156, "4850": 156, "0949": 156, "1445": 156, "1398": 156, "1022": 156, "1198": 156, "2044": 156, "1784": 156, "2483": 156, "0965": 156, "1151": 156, "1678": 156, "1966": 156, "3110": 156, "1373": 156, "0808": 156, "1881": 156, "1850": 156, "592": 156, "3268": 156, "4681": 156, "0793": 156, "0825": 156, "0443": 156, "1774": 156, "2469": 156, "1414": 156, "1449": 156, "1448": 156, "0806": 156, "1108": 156, "0640": 156, "1838": 156, "1912": 156, "0889": 156, "1709": 156, "0675": 156, "3057": 156, "1052": 156, "1939": 156, "1916": 156, "1624": 156, "1209": 156, "1287": 156, "1789": 156, "1427": 156, "1536": 156, "1186": 156, "1060": 156, "0549": 156, "0919": 156, "1360": 156, "1091": 156, "1892": 156, "1431": 156, "2312": 156, "5925": 156, "8355": 156, "8257": 156, "1300": 156, "1814": 156, "1715": 156, "1456": 156, "0726": 156, "0593": 156, "1721": 156, "2582": 156, "2167": 156, "2680": 156, "2082": 156, "2298": 156, "1493": 156, "1129": 156, "2663": 156, "1477": 156, "1157": 156, "1821": 156, "640": 156, "4940": 156, "9998": 156, "1240": 156, "0848": 156, "1944": 156, "1805": 156, "2526": 156, "0785": 156, "1544": 156, "1187": 156, "1190": 156, "2434": 156, "1744": 156, "0990": 156, "1342": 156, "1686": 156, "1353": 156, "1051": 156, "1401": 156, "2456": 156, "0843": 156, "3364": 156, "1159": 156, "654": 156, "9098": 156, "9867": 156, "7875": 156, "1169": 156, "1430": 156, "1512": 156, "1680": 156, "1158": 156, "1841": 156, "0969": 156, "0625": 156, "1673": 156, "1034": 156, "1959": 156, "1115": 156, "1465": 156, "2281": 156, "1857": 156, "1878": 156, "2164": 156, "0805": 156, "1316": 156, "1083": 156, "1823": 156, "3685": 156, "9313": 156, "1162": 156, "0858": 156, "1855": 156, "1853": 156, "0747": 156, "0382": 156, "0784": 156, "2978": 156, "1566": 156, "2748": 156, "0720": 156, "1400": 156, "3201": 156, "2403": 156, "1318": 156, "6430": 156, "8629": 156, "3222": 156, "0978": 156, "1478": 156, "1908": 156, "1598": 156, "0740": 156, "0878": 156, "3569": 156, "2908": 156, "3341": 156, "749": 156, "3389": 156, "4426": 156, "9208": 156, "1283": 156, "2569": 156, "9077": 156, "778": 156, "7937": 156, "9971": 156, "3176": 156, "1877": 156, "1479": 156, "1100": 156, "2057": 156, "1771": 156, "0909": 156, "1322": 156, "2284": 156, "1375": 156, "3376": 156, "3146": 156, "3487": 156, "0655": 156, "1473": 156, "779": 156, "9040": 156, "6813": 156, "1729": 156, "0873": 156, "2336": 156, "6529": 156, "4468": 156, "2968": 156, "6436": 156, "1371": 156, "1416": 156, "0681": 156, "1265": 156, "2033": 156, "1263": 156, "1568": 156, "1989": 156, "2185": 156, "2051": 156, "1361": 156, "1500": 156, "3189": 156, "1395": 156, "9631": 156, "2888": 156, "1166": 156, "1520": 156, "1557": 156, "0780": 156, "0796": 156, "2775": 156, "1018": 156, "1518": 156, "1923": 156, "2861": 156, "1046": 156, "1125": 156, "1859": 156, "2436": 156, "2594": 156, "1620": 156, "1879": 156, "832": 156, "4849": 156, "9463": 156, "1009": 156, "1950": 156, "8546": 156, "2256": 156, "9124": 156, "6975": 156, "2059": 156, "1054": 156, "1012": 156, "1516": 156, "1352": 156, "1183": 156, "1314": 156, "0709": 156, "6612": 156, "857": 156, "9266": 156, "8706": 156, "1176": 156, "2264": 156, "2103": 156, "1820": 156, "2952": 156, "2089": 156, "3350": 156, "1663": 156, "1845": 156, "3075": 156, "2305": 156, "1067": 156, "883": 156, "9069": 156, "8774": 156, "0976": 156, "2431": 156, "2790": 156, "1998": 156, "1345": 156, "2230": 156, "1270": 156, "2063": 156, "1919": 156, "0710": 156, "1440": 156, "2729": 156, "891": 156, "3866": 156, "6498": 156, "1830": 156, "0922": 156, "2279": 156, "2156": 156, "4838": 156, "2512": 156, "6614": 156, "893": 156, "4473": 156, "8621": 156, "0932": 156, "0833": 156, "1036": 156, "1234": 156, "2597": 156, "2961": 156, "4241": 156, "1003": 156, "1453": 156, "2484": 156, "1402": 156, "1848": 156, "2913": 156, "4893": 156, "1029": 156, "0898": 156, "1813": 156, "1812": 156, "2280": 156, "3183": 156, "2173": 156, "1726": 156, "2062": 156, "2514": 156, "1696": 156, "1793": 156, "1213": 156, "910": 156, "1235": 156, "1614": 156, "0983": 156, "3847": 156, "2677": 156, "5068": 156, "2208": 156, "1079": 156, "1646": 156, "2179": 156, "931": 156, "2071": 156, "9230": 156, "1280": 156, "2669": 156, "2873": 156, "1299": 156, "1880": 156, "0954": 156, "1507": 156, "3195": 156, "3087": 156, "1236": 156, "1547": 156, "3234": 156, "1953": 156, "9628": 156, "3819": 156, "1334": 156, "2427": 156, "0688": 156, "1150": 156, "1575": 156, "2326": 156, "1885": 156, "1590": 156, "2347": 156, "2398": 156, "2675": 156, "1551": 156, "2092": 156, "7155": 156, "9110": 156, "0484": 156, "1272": 156, "0855": 156, "2520": 156, "2053": 156, "5364": 156, "1872": 156, "2236": 156, "1175": 156, "968": 156, "9913": 156, "7962": 156, "1222": 156, "2712": 156, "1737": 156, "2466": 156, "0977": 156, "1138": 156, "1837": 156, "1588": 156, "2154": 156, "1250": 156, "2128": 156, "1563": 156, "1041": 156, "1648": 156, "996": 156, "4610": 156, "0948": 156, "2543": 156, "0678": 156, "3772": 156, "2550": 156, "2273": 156, "2080": 156, "1655": 156, "2847": 156, "1173": 156, "8326": 156, "1374": 156, "1610": 156, "2609": 156, "1562": 156, "1573": 156, "4082": 156, "0864": 156, "1109": 156, "7049": 156, "3247": 156, "3313": 156, "2412": 156, "1788": 156, "1874": 156, "1182": 156, "1450": 156, "1783": 156, "1752": 156, "2349": 156, "1064": 156, "1711": 156, "2921": 156, "1548": 156, "2064": 156, "2087": 156, "2354": 156, "3352": 156, "3725": 156, "1802": 156, "2229": 156, "1687": 156, "2994": 156, "1264": 156, "1564": 156, "2129": 156, "2468": 156, "0779": 156, "2077": 156, "1565": 156, "1973": 156, "0852": 156, "1142": 156, "3933": 156, "9101": 156, "4516": 156, "0956": 156, "4064": 156, "2334": 156, "1501": 156, "2351": 156, "1840": 156, "3560": 156, "0699": 156, "1038": 156, "1480": 156, "2290": 156, "2509": 156, "1659": 156, "1124": 156, "5706": 156, "7579": 156, "2527": 156, "1174": 156, "2454": 156, "2172": 156, "2083": 156, "2207": 156, "2204": 156, "0682": 156, "1534": 156, "2429": 156, "2147": 156, "2914": 156, "9201": 156, "3165": 156, "6129": 156, "1650": 156, "1909": 156, "6896": 156, "2198": 156, "5010": 156, "2461": 156, "3145": 156, "3307": 156, "2268": 156, "2212": 156, "4013": 156, "2124": 156, "1137": 156, "1772": 156, "1893": 156, "1825": 156, "9979": 156, "3471": 156, "1606": 156, "1144": 156, "3689": 156, "2472": 156, "2539": 156, "8228": 156, "1921": 156, "3180": 156, "1394": 156, "0972": 156, "2184": 156, "3094": 156, "3015": 156, "1113": 156, "9475": 156, "4222": 156, "1938": 156, "2357": 156, "1379": 156, "2432": 156, "3193": 156, "1658": 156, "2659": 156, "3506": 156, "6241": 156, "1928": 156, "3577": 156, "1454": 156, "1105": 156, "2079": 156, "1653": 156, "5942": 156, "3800": 156, "8966": 156, "1451": 156, "3720": 156, "2223": 156, "1505": 156, "2902": 156, "7484": 156, "2598": 156, "1962": 156, "1503": 156, "1884": 156, "3055": 156, "3623": 156, "3379": 156, "5372": 156, "3906": 156, "1657": 156, "1599": 156, "2518": 156, "1628": 156, "1681": 156, "2313": 156, "2260": 156, "1466": 156, "2523": 156, "3334": 156, "2035": 156, "1769": 156, "1569": 156, "1954": 156, "2418": 156, "4758": 156, "1833": 156, "1229": 156, "1633": 156, "8815": 156, "5111": 156, "7459": 156, "3154": 156, "1717": 156, "2239": 156, "2540": 156, "2622": 156, "1026": 156, "1819": 156, "4625": 156, "5336": 156, "1634": 156, "3513": 156, "1281": 156, "3700": 156, "3217": 156, "2397": 156, "1976": 156, "2358": 156, "4201": 156, "9819": 156, "8888": 156, "1136": 156, "0893": 156, "1576": 156, "1057": 156, "2529": 156, "2591": 156, "3651": 156, "2096": 156, "2027": 156, "1317": 156, "1245": 156, "2898": 156, "1188": 156, "9405": 156, "6393": 156, "2155": 156, "1068": 156, "0897": 156, "2904": 156, "2488": 156, "2701": 156, "1426": 156, "1676": 156, "1075": 156, "1439": 156, "1907": 156, "1742": 156, "4679": 156, "2451": 156, "1389": 156, "1502": 156, "1499": 156, "3159": 156, "1904": 156, "3446": 156, "2603": 156, "2899": 156, "1666": 156, "5694": 156, "3279": 156, "2396": 156, "2510": 156, "1638": 156, "2054": 156, "1329": 156, "1785": 156, "2803": 156, "2903": 156, "2277": 156, "1553": 156, "2196": 156, "9767": 156, "7245": 156, "2806": 156, "1649": 156, "1732": 156, "1692": 156, "1355": 156, "5263": 156, "1791": 156, "4293": 156, "1258": 156, "8761": 156, "2990": 156, "1561": 156, "1782": 156, "1679": 156, "2415": 156, "2580": 156, "1540": 156, "1661": 156, "3566": 156, "1580": 156, "3794": 156, "7383": 156, "1596": 156, "1546": 156, "1574": 156, "1581": 156, "2332": 156, "3765": 156, "3188": 156, "8794": 156, "1670": 156, "1365": 156, "2056": 156, "2918": 156, "3626": 156, "1267": 156, "9597": 156, "1852": 156, "1275": 156, "1019": 156, "5797": 156, "2651": 156, "2130": 156, "2133": 156, "7411": 156, "6580": 156, "2505": 156, "2455": 156, "3022": 156, "2342": 156, "4762": 156, "9353": 156, "3358": 156, "2578": 156, "2681": 156, "4388": 156, "1651": 156, "3619": 156, "0731": 156, "1538": 156, "3082": 156, "7281": 156, "6770": 156, "6003": 156, "3568": 156, "1422": 156, "2036": 156, "1639": 156, "1828": 156, "4476": 156, "2060": 156, "2296": 156, "5744": 156, "5555": 156, "8638": 156, "2987": 156, "1296": 156, "5150": 156, "2636": 156, "1044": 156, "2668": 156, "4124": 156, "4089": 156, "6681": 156, "1461": 156, "3172": 156, "2546": 156, "1335": 156, "1274": 156, "2161": 156, "1444": 156, "7899": 156, "7897": 156, "7775": 156, "1481": 156, "1315": 156, "3207": 156, "5505": 156, "2757": 156, "6465": 156, "6654": 156, "4002": 156, "2295": 156, "2558": 156, "2101": 156, "3994": 156, "1945": 156, "3655": 156, "2139": 156, "3009": 156, "3402": 156, "9654": 156, "1604": 156, "1949": 156, "4243": 156, "3728": 156, "4912": 156, "5603": 156, "2391": 156, "4814": 156, "2374": 156, "3065": 156, "1640": 156, "3366": 156, "2835": 156, "2311": 156, "4539": 156, "5379": 156, "6872": 156, "0777": 156, "4620": 156, "4871": 156, "2362": 156, "2025": 156, "1799": 156, "7611": 156, "9916": 156, "3337": 156, "2949": 156, "2892": 156, "1579": 156, "3045": 156, "4221": 156, "5256": 156, "4094": 156, "2885": 156, "1844": 156, "5789": 156, "2676": 156, "3602": 156, "1230": 156, "9581": 156, "7125": 156, "3085": 156, "2317": 156, "3238": 156, "2739": 156, "2947": 156, "2827": 156, "1358": 156, "9336": 156, "1248": 156, "2049": 156, "2653": 156, "4481": 156, "2394": 156, "2874": 156, "3354": 156, "3892": 156, "5136": 156, "5697": 156, "3792": 156, "1131": 156, "2934": 156, "3362": 156, "2255": 156, "2761": 156, "2686": 156, "2269": 156, "1504": 156, "3733": 156, "5277": 156, "2721": 156, "4772": 156, "2708": 156, "4001": 156, "3070": 156, "1621": 156, "1376": 156, "3535": 156, "5113": 156, "9987": 156, "1642": 156, "1470": 156, "2301": 156, "4283": 156, "9179": 156, "5283": 156, "2875": 156, "4286": 156, "8421": 156, "5164": 156, "2324": 156, "2214": 156, "3722": 156, "3005": 156, "3503": 156, "2759": 156, "3591": 156, "9733": 156, "1895": 156, "3406": 156, "5027": 156, "3192": 156, "6345": 156, "4682": 156, "4493": 156, "2997": 156, "3512": 156, "2078": 156, "4028": 156, "7613": 156, "2568": 156, "2565": 156, "4144": 156, "5070": 156, "6881": 156, "3024": 156, "1210": 156, "3034": 156, "2776": 156, "2881": 156, "2291": 156, "3423": 156, "4694": 156, "1484": 156, "4389": 156, "8141": 156, "1224": 156, "1366": 156, "2276": 156, "3101": 156, "3654": 156, "4071": 156, "2882": 156, "1418": 156, "4298": 156, "1065": 156, "2877": 156, "5179": 156, "5543": 156, "1130": 156, "1496": 156, "6510": 156, "2382": 156, "1762": 156, "4154": 156, "1770": 156, "2045": 156, "3625": 156, "2151": 156, "2414": 156, "4538": 156, "2370": 156, "1946": 156, "3044": 156, "4083": 156, "4442": 156, "2052": 156, "2046": 156, "4503": 156, "7467": 156, "2584": 156, "2439": 156, "2141": 156, "0712": 156, "5299": 156, "3573": 156, "113": 156, "4533": 156, "9856": 156, "2445": 156, "3249": 156, "0870": 156, "2685": 156, "1974": 156, "4661": 156, "8051": 156, "2234": 156, "6934": 156, "4232": 156, "4883": 156, "3232": 156, "1632": 156, "3225": 156, "9585": 156, "8791": 156, "5792": 156, "5831": 156, "1755": 156, "2833": 156, "9955": 156, "9945": 156, "2884": 156, "2657": 156, "9404": 156, "9825": 156, "2891": 156, "8557": 156, "2855": 156, "3756": 156, "8749": 156, "2925": 156, "6034": 156, "7855": 156, "2954": 156, "6781": 156, "9088": 156, "2962": 156, "6422": 156, "8414": 156, "2440": 156, "3600": 156, "2175": 156, "3564": 156, "6120": 156, "3244": 156, "2971": 156, "3311": 156, "5827": 156, "3422": 156, "4970": 156, "123": 156, "2976": 156, "7299": 156, "9351": 156, "2067": 156, "3407": 156, "4988": 156, "4304": 156, "2716": 156, "2613": 156, "124": 156, "2977": 156, "6165": 156, "3219": 156, "4613": 156, "2935": 156, "3343": 156, "3683": 156, "5333": 156, "2979": 156, "6181": 156, "4807": 156, "7254": 156, "2986": 156, "5269": 156, "1550": 156, "3169": 156, "4892": 156, "5439": 156, "4939": 156, "127": 156, "2996": 156, "6772": 156, "3288": 156, "5034": 156, "2932": 156, "3508": 156, "4666": 156, "2999": 156, "6994": 156, "5329": 156, "2286": 156, "3558": 156, "5298": 156, "2448": 156, "3955": 156, "6215": 156, "1441": 156, "3881": 156, "5157": 156, "4898": 156, "5257": 156, "6535": 156, "9204": 156, "2730": 156, "3656": 156, "7877": 156, "1555": 156, "3030": 156, "7906": 156, "4916": 156, "4707": 156, "8630": 156, "3036": 156, "8981": 156, "1775": 156, "9416": 156, "9798": 156, "5328": 156, "7300": 156, "2065": 156, "3063": 156, "7990": 156, "2984": 156, "2700": 156, "1508": 156, "2381": 156, "6543": 156, "3076": 156, "9594": 156, "8717": 156, "2183": 156, "6194": 156, "1469": 156, "3613": 156, "2258": 156, "3086": 156, "6432": 156, "4630": 156, "3900": 156, "6269": 156, "2785": 156, "1693": 156, "2592": 156, "2985": 156, "2145": 156, "3166": 156, "3863": 156, "5855": 156, "3861": 156, "8559": 156, "2094": 156, "3184": 156, "5343": 156, "7513": 156, "8897": 156, "3525": 156, "8055": 156, "5515": 156, "8221": 156, "3530": 156, "8225": 156, "8787": 156, "5092": 156, "wvn": 156, "wvng": 156, "irg": 156, "vibration_view": 156, "ir_inten": 156, "no_norm_mod": 156, "thymin": 157, "thymine_xyz": [157, 159], "095722": [157, 159], "037785": [157, 159], "093615": [157, 159], "011848": [157, 159], "408694": [157, 159], "113404": [157, 159], "204706": [157, 159], "048475": [157, 159], "052807": [157, 159], "302595": [157, 159], "390520": [157, 159], "249226": [157, 159], "214596": [157, 159], "023933": [157, 159], "378238": [157, 159], "017387": [157, 159], "607231": [157, 159], "171757": [157, 159], "270287": [157, 159], "735594": [157, 159], "076393": [157, 159], "098029": [157, 159], "096194": [157, 159], "424990": [157, 159], "052976": [157, 159], "874860": [157, 159], "891573": [157, 159], "002157": [157, 159], "170639": [157, 159], "310554": [157, 159], "671531": [157, 159], "743694": [157, 159], "104794": [157, 159], "301905": [157, 159], "554734": [157, 159], "440234": [157, 159], "292790": [157, 159], "119685": [157, 159], "106201": [157, 159], "053626": [157, 159], "612452": [157, 159], "215637": [157, 159], "446827": [157, 159], "892203": [157, 159], "107092": [157, 159], "volumetr": 157, "gen_cub": 157, "cube_dict": 157, "water_homo": 157, "water_lumo": 157, "water_a_dens": 157, "overlai": 157, "server": 157, "strick": 157, "mo_1": 157, "mo_2": 157, "mo_2p_1": 157, "mo_2p_2": 157, "mo_2p_3": 157, "2p_1": 157, "2p_2": 157, "2p_3": 157, "rad_den_1": 157, "rad_den_2": 157, "rad_den_2p": 157, "subshel": 157, "xrd": 159, "photosystem": 159, "queri": 159, "6w1o": 159, "cartoon": 159, "addstyl": 159, "cartoonish": 159, "strand": 159, "ribbon": 159, "manganes": 159, "calcium": 159, "sigma_j": [], "sigma_b": [], "b1": 86, "70044182e": [], "56150602e": [], "10345571e": [], "15522514e": [], "30146331e": [], "99772127e": [], "39047427e": [], "53094040e": [], "11732022e": [], "47382956e": [], "10397126e": [], "62878536e": [], "03013639e": [], "77028955e": [], "02803164e": [], "29492384e": [], "14491548e": [], "95880701e": [], "60357283e": [], "02002681e": [], "63477216e": [], "08027332e": [], "60693759e": [], "06166779e": [], "27555344e": [], "46504516e": [], "47289562e": [], "95010181e": [], "36845063e": [], "64296092e": [], "47476351e": [], "21901604e": [], "06518883e": [], "30358806e": [], "64737227e": [], "10790568e": [], "74380699e": [], "03984069e": [], "59216448e": [], "57225836e": [], "0j": [], "0270044182091009": [], "electric_dipol": 86, "56032976e": [], "10615002e": [], "40555994e": [], "38925486e": [], "07332712e": [], "00817015e": [], "13074547e": [], "81087785e": [], "08052768e": [], "12729710e": [], "45466896e": [], "44399180e": [], "41074775e": [], "56084913e": [], "10072192e": [], "40258958e": [], "27324992e": [], "07014695e": [], "96490165e": [], "12747250e": [], "00710917e": [], "09998227e": [], "07009519e": [], "46929798e": [], "50062613e": [], "47224873e": [], "48351857e": [], "64898746e": [], "09414829e": [], "60665282e": [], "18679500e": [], "98494415e": [], "22489962e": [], "21381762e": [], "06014225e": [], "07252962e": [], "ndim": 86, "e2_ref": 86, "conj": 86, "b1_ref": 86, "nameerror": [], "traceback": [], "61661005e": [], "03746199e": [], "15254468e": [], "28651384e": [], "68699343e": [], "lrs_result": 86, "84611698e": [], "52830782e": [], "96457295e": [], "15586302e": [], "05423980e": [], "34024945": 86, "36669362": 86, "76493335": 86, "70960170": 86, "21128138": 86, "n_ref": 86, "a1": 86, "298489": 86}, "objects": {}, "objtypes": {}, "objnames": {}, "titleterms": {"us": [0, 33, 133, 157], "jupyt": 0, "notebook": [0, 42], "cell": 0, "type": [0, 133], "markdown": 0, "code": 0, "python": [0, 17], "ecosystem": 0, "molecular": [0, 13, 18, 25, 26, 49, 53, 63, 82, 83, 91, 125, 137, 139, 147, 155, 157, 159], "structur": [0, 57, 65, 72, 128, 133, 137, 138, 139, 152, 155, 159], "visual": [0, 4, 13, 65, 94, 125, 136, 137, 153], "electron": [0, 3, 4, 17, 25, 26, 29, 30, 31, 79, 86, 88, 89, 97, 113, 128, 137, 149, 150, 152, 153], "perform": 0, "scf": [0, 7, 13, 14, 15, 39, 65, 111, 131, 137, 144], "calcul": [0, 7, 10, 14, 33, 38, 39, 65, 70, 72, 81, 83, 90, 94, 115, 126, 132, 136, 144, 148, 151], "orbit": [0, 3, 13, 24, 25, 26, 30, 38, 94, 97, 125, 137, 143, 150, 153, 157], "basi": [0, 3, 4, 10, 14, 15, 22, 26, 81, 89, 128, 143, 146, 149], "set": [0, 4, 7, 10, 26, 58, 65, 81, 89, 128, 143, 146, 149], "effect": [0, 143, 149], "list": 0, "plot": [0, 2, 81, 99, 125], "result": [0, 83, 89, 106, 148], "potenti": [0, 17, 22, 33, 35, 52, 62, 100, 135], "energi": [0, 2, 4, 8, 14, 15, 17, 22, 27, 29, 33, 39, 46, 52, 65, 72, 80, 81, 83, 86, 87, 112, 113, 136, 148], "surfac": [0, 52], "construct": [0, 52, 68, 70, 140], "pe": [0, 51, 52], "interpol": [0, 51, 52], "spline": 0, "fit": [0, 47, 62], "harmon": [0, 47, 66], "function": [0, 2, 5, 11, 19, 20, 26, 30, 32, 38, 86, 88, 89, 99, 118, 143, 150], "exampl": [0, 21, 81, 82, 83], "einstein": 0, "summat": 0, "ao": [0, 10, 14, 15, 17], "mo": [0, 17, 22, 144, 145], "transform": [0, 17, 30, 38, 45, 52], "eigenvalu": [0, 10], "eigenvector": [0, 142], "dictionari": 0, "isinst": 0, "np": 0, "zero": 0, "ones": 0, "rad2deg": 0, "deg2rad": 0, "extern": [0, 99], "websit": 0, "tutori": 0, "how": 1, "cite": 1, "contact": 1, "avail": 2, "xc": [2, 7], "hartre": [2, 10, 12, 15, 22, 33, 85], "fock": [2, 7, 10, 12, 15, 17, 22, 29, 33, 85], "mp2": [2, 22, 33, 46], "fci": 2, "dft": [2, 20, 46, 49, 104, 124, 137, 143, 144, 145, 147], "configur": [3, 33, 75], "interact": [3, 7, 8, 33, 47, 75, 143], "gener": [3, 9, 10, 19, 56, 97, 103], "theori": [3, 5, 8, 15, 20, 21, 27, 32, 64, 82, 91, 111], "The": [3, 21, 22, 52, 70, 144, 146], "n": [3, 16, 30], "ci": [3, 46, 75], "hamiltonian": [3, 17, 25, 29, 81], "direct": [3, 14], "densiti": [3, 4, 5, 18, 19, 20, 28, 29, 30, 33, 38, 49, 70, 153, 157], "matric": [3, 38, 70, 150], "natur": [3, 24, 94, 153], "truncat": [3, 75], "restrict": [3, 24, 122, 148], "excit": [3, 31, 46, 70, 72, 81, 86, 97, 107, 113, 143, 148, 153], "size": [3, 22, 27, 72], "consist": [3, 21, 22, 72, 150], "correl": [4, 8, 19, 20, 21, 89, 120], "One": [4, 17, 25, 28, 29, 33], "particl": [4, 28, 29, 30, 33], "two": [4, 17, 25, 28, 29, 82, 99, 117, 144, 150], "cusp": 4, "converg": [4, 14], "first": [6, 27, 38, 46, 84, 98], "order": [6, 17, 26, 27, 38, 46, 49, 76, 82, 84, 86, 98], "properti": [6, 37, 38, 46, 49, 61, 72, 82, 83, 84, 86, 91, 113, 158], "numer": [6, 27, 33, 46, 49, 83], "integr": [6, 14, 17, 18, 22, 55, 150], "analyt": [6, 46, 49, 99], "optim": [7, 13, 14, 44, 57, 60, 65, 101, 131, 133, 136, 137, 139, 156], "up": [7, 65, 81], "system": [7, 14, 25, 31, 45, 72, 99, 133, 143, 147], "refer": [7, 10, 14, 22, 38, 39, 67, 70, 72, 94, 97, 115, 122, 143, 148], "contribut": [7, 79, 82, 125, 142], "matrix": [7, 10, 17, 25, 26, 33, 70, 72, 113], "procedur": [7, 15], "self": [7, 21, 143], "error": [7, 143], "dispers": [8, 76, 98, 99], "long": 8, "rang": [8, 19], "perturb": [8, 22, 27, 38, 49, 88], "aspect": [9, 56, 98, 103, 143], "diagon": [10, 70], "equat": [10, 15, 19, 27, 49, 86, 100, 113], "solv": [10, 27], "problem": 10, "standard": [10, 148], "case": 10, "non": [10, 39, 47, 143, 148], "linear": [10, 17, 26, 74, 82, 86, 89, 90, 109], "depend": [10, 83, 88, 91, 96, 104, 125, 142], "overlap": [10, 17, 26, 113, 144], "orthogon": [10, 38], "symmetri": [11, 63, 97, 98, 122], "activ": [11, 65, 131], "passiv": 11, "point": [11, 18], "view": 11, "invari": 11, "observ": [11, 88, 99], "oper": [11, 25, 28, 29, 39, 86, 88], "group": 11, "charact": 11, "tabl": 11, "c_": 11, "mathsf": 11, "2v": 11, "2h": 11, "d_": 11, "wave": [11, 26, 30, 32, 118, 143, 150], "hf": [13, 33, 46, 49, 72, 139, 143], "veloxchem": [13, 43, 76, 88, 89, 98, 100, 106], "defin": [13, 99, 100], "molecul": [13, 26, 59, 65, 81], "inform": [13, 26], "some": 14, "paramet": [14, 86, 87, 96], "get": [14, 43, 81], "measur": [14, 89, 126, 147], "iter": 14, "acceler": 14, "invers": 14, "subspac": 14, "lagrangian": 15, "canon": [15, 55], "form": 15, "In": [15, 76, 89, 98, 111], "koopman": [15, 144, 145], "theorem": [15, 16, 108, 144, 145], "brillouin": 15, "roothaan": 15, "hall": 15, "scheme": 15, "hohenberg": 16, "kohn": [16, 19], "hk": 16, "i": [16, 144, 145], "ii": 16, "represent": [16, 72], "exposur": 17, "layer": 17, "kinet": 17, "nuclear": [17, 79], "momentum": 17, "electr": [17, 76, 82, 84, 88, 89, 91, 98, 113], "dipol": [17, 33, 38, 39, 76, 78, 81, 82, 83, 84, 89, 98, 113], "moment": [17, 33, 38, 39, 83, 84, 89], "magnet": 17, "repuls": 17, "convent": 17, "driven": 17, "kernel": 18, "grid": 18, "sham": 19, "method": [19, 21, 23, 60, 65, 72, 83, 93, 100, 118, 122, 143, 144, 145, 149], "exchang": 19, "local": [19, 37, 38, 42, 143], "approxim": [19, 25, 33, 108, 115, 146], "lda": 19, "gradient": [19, 46, 48, 60, 61, 65, 86, 113], "gga": 19, "meta": 19, "mgga": 19, "hybrid": 19, "separ": [19, 69, 106], "known": 19, "defici": 19, "mc": 20, "pdft": 20, "strong": [20, 21], "pair": 20, "multiconfigur": [20, 21], "mcscf": [21, 33, 101, 124], "static": [21, 91, 120], "field": [21, 47, 62, 82, 83, 88, 91, 96, 99, 133, 136], "illustr": [21, 22, 27, 28, 29, 86, 88, 90, 97], "implement": [21, 60, 71, 81, 94, 110], "multirefer": [21, 23, 93], "m\u00f8ller": 22, "plesset": 22, "partit": 22, "expans": [22, 83, 86, 88, 89], "fluctuat": 22, "close": [22, 33], "shell": [22, 33, 121, 157], "state": [22, 29, 30, 33, 46, 52, 59, 64, 65, 70, 72, 80, 97, 100, 101, 107, 122, 144, 145, 146, 148, 153], "correct": [22, 33], "taylor": 22, "unrestrict": [24, 122], "element": 25, "singl": [25, 31, 122], "mani": [25, 30, 31], "action": 25, "one": 25, "slater": [25, 29, 30, 31], "determin": [25, 29, 30, 31, 86, 87, 97, 99], "commut": 25, "spin": [25, 31, 86, 88, 97, 114, 122, 143], "adiabat": [25, 108], "born": 25, "oppenheim": 25, "expect": [25, 28, 88], "valu": [25, 28, 88], "combin": 26, "atom": [26, 38, 142, 150, 157], "assign": [26, 126], "librari": 26, "number": [26, 70], "addit": [26, 47], "rayleigh": 27, "schr\u00f6dinger": [27, 100], "rspt": 27, "master": 27, "extens": 27, "zeroth": 27, "second": [27, 29, 38, 49, 76], "reduc": [28, 66], "probabilist": [28, 30], "interpret": [28, 30], "quantiz": 29, "space": [29, 30, 106, 148], "creation": 29, "annihil": 29, "ground": [29, 46, 52, 59, 144, 145, 146], "f": 29, "4": 29, "10": 29, "term": [29, 47], "hilbert": 30, "vector": [30, 86, 142, 150], "pauli": 30, "principl": 30, "unitari": 30, "normal": [30, 156], "all": 31, "high": [31, 82, 89, 122], "homo": 31, "lumo": 31, "exercis": [33, 70, 92, 126, 131, 146], "sever": 33, "amplitud": 33, "t": [33, 42, 65], "o": 33, "h": 33, "dissoci": 33, "curv": 33, "unrelax": 33, "relax": [33, 143], "ozon": 33, "chromium": 33, "dimer": [33, 81], "chelpg": 34, "charg": [34, 36, 38, 41, 105], "embed": [35, 39, 40], "esp": 36, "loprop": 38, "polaris": 38, "t0": 38, "rearrang": 38, "t1": 38, "gram": 38, "schmidt": 38, "block": 38, "t2": 38, "l\u00f6dwin": 38, "orthonorm": 38, "occupi": 38, "virtual": 38, "t3": 38, "project": 38, "t4": 38, "orthogonalizatio": 38, "polariz": [38, 39, 40, 82, 83, 89, 113], "from": [38, 52, 106, 119, 133, 138, 144, 148], "respons": [38, 75, 76, 82, 86, 88, 89, 90, 91, 98, 99, 101, 109, 111], "ga": 39, "phase": [39, 97], "water": [39, 52], "liquid": 39, "solvat": [39, 147], "resp": 41, "instal": 42, "conda": 42, "faster": 42, "solver": 42, "For": 42, "window": 42, "user": [42, 100], "environ": 42, "file": [42, 157], "If": 42, "your": 42, "doesn": 42, "run": [42, 54, 81], "compil": 42, "echem": 42, "book": 42, "start": 43, "our": 43, "vision": 43, "who": 43, "we": 43, "ar": 43, "softwar": 43, "gator": 43, "multi": [43, 97, 122], "psi": 43, "other": 43, "tool": 43, "geometr": 43, "xtb": [43, 136, 139], "openmm": 43, "py3dmol": 43, "open": [43, 121], "babel": 43, "valet": 43, "conform": 44, "search": 44, "choic": [45, 55], "coordin": [45, 52, 58, 66], "cartesian": [45, 52, 66], "intern": [45, 52, 58, 66], "between": 45, "tdhf": 46, "tddft": [46, 124, 144, 147, 148], "forc": [47, 62, 66, 133, 136], "bond": [47, 120, 133], "stretch": 47, "anharmon": 47, "angl": [47, 62], "bend": 47, "torsion": 47, "van": 47, "der": 47, "waal": 47, "electrostat": 47, "hessian": [49, 50, 66, 86, 113, 131], "cphf": 49, "vibrat": [50, 66, 100, 129, 131, 156], "techniqu": 51, "dynam": [53, 120, 147, 155], "simul": 54, "ensembl": 55, "time": [55, 88, 91, 99, 104], "microcanon": 55, "nve": 55, "nvt": 55, "thermostat": 55, "isotherm": 55, "isobar": 55, "npt": 55, "barostat": 55, "euler": 55, "verlet": 55, "veloc": 55, "constrain": 58, "freez": 58, "scan": 58, "larger": [59, 147], "descent": 60, "conjug": 60, "newton": 60, "raphson": 60, "quasi": [60, 87, 112], "note": 60, "ir": [61, 130, 131], "intens": [61, 82, 113, 131], "raman": [61, 131, 132], "reparameter": 62, "dihedr": 62, "gaff": 62, "qm": 62, "weight": [62, 66], "exclud": 62, "tricki": 62, "transit": [64, 65, 81, 94, 100, 153], "irc": 65, "import": [65, 81], "modul": [65, 81], "find": 65, "driver": [65, 81], "frequenc": [65, 66], "free": 65, "compar": 65, "reactant": 65, "product": 65, "minim": 65, "go": 65, "forward": 65, "path": 65, "analysi": [66, 70, 113, 125, 131, 142, 153], "mass": 66, "translat": 66, "rotat": [66, 82, 97, 100], "frame": [66, 82], "displac": 66, "constant": 66, "algebra": 68, "diagrammat": 68, "core": [69, 106, 143, 147, 148], "valenc": [69, 106, 143, 144, 147, 148, 157], "adc": [70, 72, 124, 144, 145, 147], "summari": 70, "isr": 70, "0": 70, "1": 70, "step": [70, 144], "2": [70, 72, 147], "3": 70, "absorpt": [70, 81, 95, 117, 124, 144, 148], "spectrum": [70, 126, 132, 138, 142, 144, 151], "attach": [70, 153], "detach": [70, 153], "promot": 70, "hpc": [71, 119], "qc": 71, "intermedi": 72, "deriv": [72, 83], "via": 72, "explicit": 72, "express": 72, "comparison": [72, 106, 124, 139, 148], "relat": [72, 78], "individu": 72, "composit": 72, "polar": [73, 82, 125, 142], "propag": [73, 99], "birefring": 74, "dichroism": [74, 77], "circular": [74, 82], "axial": 74, "full": [75, 106, 134, 148], "cubic": 76, "hyperpolariz": [76, 83, 98], "pertin": [76, 98], "optic": [76, 98], "process": [76, 98], "isotrop": [76, 82, 89], "quantiti": 76, "equival": 78, "exciton": [80, 81], "coupl": [80, 143, 147, 148], "model": [80, 81, 128, 146], "subsystem": 80, "initi": [81, 139], "monom": 81, "print": [81, 125], "ecd": 81, "spectra": [81, 100, 124, 125, 142, 144, 158], "experi": [82, 151], "orient": 82, "laboratori": 82, "averag": [82, 101], "strength": 82, "spatial": 82, "formula": 82, "rank": 82, "five": 82, "tensor": [82, 91], "applic": 82, "quadrupolar": 82, "quadrat": [82, 98], "finit": 83, "differenti": 83, "multipol": 84, "quadrupol": 84, "baker": 86, "campbel": 86, "hausdorff": 86, "repres": 88, "monochromat": 88, "adapt": [86, 88], "transfer": [88, 105], "signific": 89, "anisotrop": 89, "compon": 89, "accuraci": [89, 149], "requir": 89, "cauchi": 89, "real": 89, "complex": [89, 113, 133], "concept": 90, "dioxetan": 92, "chemiluminesc": 92, "uv": [95, 123], "vi": [95, 123], "parameter": 97, "isol": 97, "level": 99, "pole": 99, "rovibron": 100, "numerov": 100, "": 100, "rovibr": 100, "vibron": 100, "casci": 101, "specif": 101, "select": [102, 128, 149], "rule": 102, "cv": [106, 143, 144, 145, 147, 148], "foundat": 108, "rung": 108, "gross": 108, "rpa": 113, "eigenst": [113, 125, 148], "flip": 114, "tamm": [115, 146], "dancoff": [115, 146], "triplet": 116, "instabl": 116, "photon": 117, "center": 119, "b": 119, "comput": 119, "chemistri": 119, "laptop": 119, "versu": [120, 122, 149], "break": 120, "At": 120, "equilibrium": 120, "distanc": 120, "low": 122, "broken": 122, "solut": [122, 142, 146], "spectroscopi": [123, 129, 130, 132, 141, 144, 148], "cpp": [124, 144, 145], "domin": 125, "cost": [126, 147], "save": [126, 147], "fluoresc": 127, "recommend": [128, 149], "geometri": [131, 136, 156], "build": 133, "smile": 133, "branch": 133, "substitut": 133, "ring": 133, "more": 133, "download": 133, "pdb": 133, "databank": 133, "assembl": 134, "workflow": [134, 140, 145], "global": 135, "warm": 135, "methan": 136, "combust": 136, "reaction": 136, "specifi": 137, "k": 137, "x": [141, 144, 147, 148], "rai": [141, 144, 148], "look": 142, "decomposit": 142, "special": 143, "ioniz": [143, 148], "de": 143, "includ": 143, "deltascf": [143, 144], "base": 143, "rel": 143, "scalar": 143, "relativist": [143, 149], "consider": 143, "hole": 143, "tailor": 143, "post": 143, "aufbau": 143, "spuriou": 143, "mix": 143, "xa": [143, 145, 146, 147, 148], "photoemiss": 144, "maximum": 144, "delta": [144, 145], "textrm": 144, "decoupl": 144, "continuum": 144, "casscf": 144, "emiss": 144, "reson": 144, "inelast": 144, "scatter": 144, "approach": 144, "cheat": 145, "sheet": 145, "typic": 145, "xp": 145, "xe": [145, 147, 148], "chemic": 146, "shift": 146, "augment": 146, "uracil": 147, "phthalocyanin": 147, "transient": 148, "impact": 148, "channel": 148, "consid": 148, "revers": 148, "precis": 149, "stuctur": 149, "unit": 150, "notat": 150, "convers": 150, "indic": 150, "common": 150, "short": 150, "hand": 150, "broaden": 151, "lorentzian": 151, "gaussian": 151, "voigt": 151, "md": 154, "trajectori": 154, "mode": 156, "orbitalview": 157, "cube": 157, "radial": 157, "distribut": 157, "sub": 157, "setup": 86}, "envversion": {"sphinx.domains.c": 3, "sphinx.domains.changeset": 1, "sphinx.domains.citation": 1, "sphinx.domains.cpp": 9, "sphinx.domains.index": 1, "sphinx.domains.javascript": 3, "sphinx.domains.math": 2, "sphinx.domains.python": 4, "sphinx.domains.rst": 2, "sphinx.domains.std": 2, "sphinx.ext.intersphinx": 1, "sphinxcontrib.bibtex": 9, "sphinx": 60}, "alltitles": {"Using Jupyter notebooks": [[0, "using-jupyter-notebooks"]], "Cell types": [[0, "cell-types"]], "Markdown cells": [[0, "markdown-cells"]], "Code cells": [[0, "code-cells"]], "Python ecosystem": [[0, "python-ecosystem"]], "Molecular structure": [[0, "molecular-structure"], [159, "molecular-structure"]], "Visualize": [[0, "visualize"]], "Electronic structure": [[0, "electronic-structure"], [152, "electronic-structure"]], "Perform SCF calculations": [[0, "perform-scf-calculations"]], "Visualize molecular orbitals": [[0, "visualize-molecular-orbitals"]], "Basis set effects": [[0, "basis-set-effects"]], "Python lists": [[0, "python-lists"]], "Plotting results": [[0, "plotting-results"]], "Potential energy surfaces": [[0, "potential-energy-surfaces"]], "Constructing a PES": [[0, "constructing-a-pes"]], "Interpolation with spline": [[0, "interpolation-with-spline"]], "Fit harmonic function": [[0, "fit-harmonic-function"]], "Functions and examples": [[0, "functions-and-examples"]], "Einstein summation": [[0, "einstein-summation"]], "AO to MO transformation": [[0, "ao-to-mo-transformation"], [17, "ao-to-mo-transformation"]], "Eigenvalues and eigenvectors": [[0, "eigenvalues-and-eigenvectors"]], "Dictionaries": [[0, "dictionaries"]], "Function isinstance": [[0, "function-isinstance"]], "Functions np.zeros and np.ones": [[0, "functions-np-zeros-and-np-ones"]], "Functions np.rad2deg and np.deg2rad": [[0, "functions-np-rad2deg-and-np-deg2rad"]], "External websites and tutorials": [[0, "external-websites-and-tutorials"]], "How to cite and contact": [[1, "how-to-cite-and-contact"]], "Available XC functionals": [[2, "available-xc-functionals"]], "Hartree\u2013Fock": [[2, "hartreefock"], [12, "hartree-fock"], [85, "hartreefock"]], "MP2": [[2, "mp2"], [33, "mp2"], [46, "mp2"]], "FCI": [[2, "fci"]], "DFT": [[2, "dft"], [46, "dft"], [49, "dft"]], "Plotting the energies": [[2, "plotting-the-energies"]], "Configuration interaction": [[3, "configuration-interaction"], [33, "configuration-interaction"], [75, "configuration-interaction"]], "General theory": [[3, "general-theory"]], "The N-electron basis": [[3, "the-n-electron-basis"]], "The CI Hamiltonian": [[3, "the-ci-hamiltonian"]], "Direct CI": [[3, "direct-ci"]], "Density matrices and natural orbitals": [[3, "density-matrices-and-natural-orbitals"]], "Truncated CI": [[3, "truncated-ci"], [75, "truncated-ci"]], "Restricting the excitations": [[3, "restricting-the-excitations"]], "Size consistency": [[3, "size-consistency"], [22, "size-consistency"], [72, "size-consistency"]], "Electron correlation": [[4, "electron-correlation"], [89, "electron-correlation"]], "Correlation energy": [[4, "correlation-energy"]], "Visualizing electron correlation": [[4, "visualizing-electron-correlation"]], "One-particle density": [[4, "one-particle-density"], [28, "one-particle-density"], [29, "one-particle-density"]], "Two-particle density": [[4, "two-particle-density"], [28, "two-particle-density"]], "Electron cusp and basis set convergence": [[4, "electron-cusp-and-basis-set-convergence"]], "Density functional theory": [[5, "density-functional-theory"]], "First-order properties": [[6, "first-order-properties"], [46, "first-order-properties"], [84, "first-order-properties"]], "Numerical integration": [[6, "numerical-integration"]], "Analytic integration": [[6, "analytic-integration"]], "SCF optimization": [[7, "scf-optimization"], [13, "scf-optimization"], [14, "scf-optimization"], [137, "scf-optimization"]], "Setting up the system": [[7, "setting-up-the-system"]], "Reference calculation": [[7, "reference-calculation"], [10, "reference-calculation"], [14, "reference-calculation"], [39, "reference-calculation"], [94, "reference-calculation"], [115, "reference-calculation"]], "XC contribution to Fock matrix": [[7, "xc-contribution-to-fock-matrix"]], "SCF procedure": [[7, "scf-procedure"], [15, "scf-procedure"]], "Self-interaction error": [[7, "self-interaction-error"]], "Dispersion interactions": [[8, "dispersion-interactions"]], "Long-range interaction energy": [[8, "long-range-interaction-energy"]], "Dispersion and correlation": [[8, "dispersion-and-correlation"]], "Dispersion by perturbation theory": [[8, "dispersion-by-perturbation-theory"]], "General aspects": [[9, "general-aspects"], [56, "general-aspects"], [103, "general-aspects"]], "Fock matrix diagonalization": [[10, "fock-matrix-diagonalization"]], "Hartree\u2013Fock equation": [[10, "hartreefock-equation"], [15, "hartreefock-equation"]], "Solving a generalized eigenvalue problem": [[10, "solving-a-generalized-eigenvalue-problem"]], "Standard case": [[10, "standard-case"]], "Non-standard case": [[10, "non-standard-case"]], "Linear dependence in basis set": [[10, "linear-dependence-in-basis-set"]], "Diagonalizing the overlap matrix": [[10, "diagonalizing-the-overlap-matrix"]], "Orthogonalizing the AO basis": [[10, "orthogonalizing-the-ao-basis"]], "Symmetry": [[11, "symmetry"]], "Active or passive point of view": [[11, "active-or-passive-point-of-view"]], "Invariance of observables": [[11, "invariance-of-observables"]], "Symmetry operations": [[11, "symmetry-operations"]], "Point groups": [[11, "point-groups"]], "Character tables": [[11, "character-tables"]], "C_\\mathsf{2v}": [[11, "c-mathsf-2v"]], "C_\\mathsf{2h}": [[11, "c-mathsf-2h"]], "D_\\mathsf{2h}": [[11, "d-mathsf-2h"]], "Wave function symmetry": [[11, "wave-function-symmetry"]], "HF in VeloxChem": [[13, "hf-in-veloxchem"]], "Define the molecule": [[13, "define-the-molecule"]], "SCF information": [[13, "scf-information"]], "Visualizing molecular orbitals": [[13, "visualizing-molecular-orbitals"], [125, "visualizing-molecular-orbitals"], [137, "visualizing-molecular-orbitals"]], "SCF energy": [[14, "scf-energy"]], "Some system parameters": [[14, "some-system-parameters"]], "Getting integrals in AO basis": [[14, "getting-integrals-in-ao-basis"]], "Convergence measure": [[14, "convergence-measure"]], "SCF iterations": [[14, "scf-iterations"], [14, "id2"]], "Convergence acceleration": [[14, "convergence-acceleration"]], "Direct inversion iterative subspace": [[14, "direct-inversion-iterative-subspace"]], "Hartree\u2013Fock theory": [[15, "hartreefock-theory"]], "Lagrangian": [[15, "lagrangian"]], "Canonical form": [[15, "canonical-form"]], "In AO basis": [[15, "in-ao-basis"]], "Hartree\u2013Fock energy": [[15, "hartreefock-energy"]], "Koopmans theorem": [[15, "koopmans-theorem"]], "Brillouin theorem": [[15, "brillouin-theorem"]], "Roothaan\u2013Hall scheme": [[15, "roothaanhall-scheme"]], "Hohenberg\u2013Kohn theorems": [[16, "hohenbergkohn-theorems"]], "HK theorem I": [[16, "hk-theorem-i"]], "HK theorem II": [[16, "hk-theorem-ii"]], "N-representability": [[16, "n-representability"]], "Integrals": [[17, "integrals"]], "Ordering": [[17, "ordering"]], "Exposure to Python layer": [[17, "exposure-to-python-layer"]], "Overlap": [[17, "overlap"]], "Kinetic energy": [[17, "kinetic-energy"]], "Nuclear potential": [[17, "nuclear-potential"]], "One-electron Hamiltonian": [[17, "one-electron-hamiltonian"]], "Linear momentum": [[17, "linear-momentum"]], "Electric dipole moment": [[17, "electric-dipole-moment"]], "Magnetic dipole moment": [[17, "magnetic-dipole-moment"]], "Electron repulsion integrals": [[17, "electron-repulsion-integrals"]], "Integral transformations": [[17, "integral-transformations"]], "One-electron integrals": [[17, "one-electron-integrals"]], "MO to AO transformation": [[17, "mo-to-ao-transformation"]], "Two-electron integrals": [[17, "two-electron-integrals"], [150, "two-electron-integrals"]], "Conventional": [[17, "conventional"]], "Fock-matrix driven": [[17, "fock-matrix-driven"]], "Kernel integration": [[18, "kernel-integration"]], "Molecular grid points": [[18, "molecular-grid-points"]], "Density on grid points": [[18, "density-on-grid-points"]], "Kohn\u2013Sham method": [[19, "kohnsham-method"]], "Kohn\u2013Sham equation": [[19, "kohnsham-equation"]], "Exchange\u2013correlation functionals": [[19, "exchangecorrelation-functionals"]], "Local density approximation (LDA)": [[19, "local-density-approximation-lda"]], "Generalized gradient approximation (GGA)": [[19, "generalized-gradient-approximation-gga"]], "Meta generalized gradient approximation (mGGA)": [[19, "meta-generalized-gradient-approximation-mgga"]], "Hybrid exchange-correlation functionals": [[19, "hybrid-exchange-correlation-functionals"]], "Range separated exchange-correlation functionals": [[19, "range-separated-exchange-correlation-functionals"]], "Known deficiencies": [[19, "known-deficiencies"]], "MC-PDFT": [[20, "mc-pdft"]], "DFT for strong correlation": [[20, "dft-for-strong-correlation"]], "Pair-density functional theory": [[20, "pair-density-functional-theory"]], "Multiconfigurational pair-density functional theory": [[20, "multiconfigurational-pair-density-functional-theory"]], "MCSCF": [[21, "mcscf"], [33, "mcscf"], [124, "mcscf"]], "Strong/static correlation": [[21, "strong-static-correlation"]], "The Multiconfigurational Self-Consistent Field method (MCSCF)": [[21, "the-multiconfigurational-self-consistent-field-method-mcscf"]], "Illustrative example": [[21, "illustrative-example"]], "Theory": [[21, "theory"], [111, "theory"]], "Implementation": [[21, "implementation"], [60, "implementation"], [60, "id2"], [60, "id3"], [81, "implementation"], [94, "implementation"], [110, "implementation"]], "Multireference correlation": [[21, "multireference-correlation"]], "M\u00f8ller\u2013Plesset": [[22, "mollerplesset"]], "M\u00f8ller\u2013Plesset partitioning": [[22, "mollerplesset-partitioning"]], "Perturbation expansion in the fluctuation potential": [[22, "perturbation-expansion-in-the-fluctuation-potential"]], "Closed-shell reference state": [[22, "closed-shell-reference-state"]], "Illustration": [[22, "illustration"], [28, "illustration"], [28, "id3"], [88, "illustration"], [86, "illustration"]], "Hartree\u2013Fock reference state": [[22, "hartreefock-reference-state"]], "Integrals in the MO basis": [[22, "integrals-in-the-mo-basis"]], "The MP2 energy correction": [[22, "the-mp2-energy-correction"]], "Taylor expansion of the energy": [[22, "taylor-expansion-of-the-energy"]], "Multireference methods": [[23, "multireference-methods"], [93, "multireference-methods"]], "Natural orbitals": [[24, "natural-orbitals"]], "Restricted orbitals": [[24, "restricted-orbitals"]], "Unrestricted orbitals": [[24, "unrestricted-orbitals"]], "Operators and matrix elements": [[25, "operators-and-matrix-elements"]], "Single-electron systems": [[25, "single-electron-systems"], [31, "single-electron-systems"]], "Many-electron systems": [[25, "many-electron-systems"], [31, "many-electron-systems"]], "One-electron operators": [[25, "one-electron-operators"], [29, "one-electron-operators"]], "Action of one-electron operators on Slater determinants": [[25, "action-of-one-electron-operators-on-slater-determinants"]], "Commutator of one-electron operators": [[25, "commutator-of-one-electron-operators"]], "Two-electron operators": [[25, "two-electron-operators"], [29, "two-electron-operators"]], "Matrix elements for Slater determinants": [[25, "matrix-elements-for-slater-determinants"]], "Spin orbitals": [[25, "spin-orbitals"]], "Molecular orbitals": [[25, "molecular-orbitals"], [157, "molecular-orbitals"]], "Molecular Hamiltonian": [[25, "molecular-hamiltonian"]], "Adiabatic Born\u2013Oppenheimer approximation": [[25, "adiabatic-bornoppenheimer-approximation"]], "Matrix element of electronic Hamiltonian": [[25, "matrix-element-of-electronic-hamiltonian"]], "Expectation value of one-electron Hamiltonian": [[25, "expectation-value-of-one-electron-hamiltonian"]], "Expectation value of two-electron Hamiltonian": [[25, "expectation-value-of-two-electron-hamiltonian"]], "Expectation value of electronic Hamiltonian": [[25, "expectation-value-of-electronic-hamiltonian"]], "Orbitals and basis sets": [[26, "orbitals-and-basis-sets"]], "Electronic wave functions and molecular orbitals": [[26, "electronic-wave-functions-and-molecular-orbitals"]], "Linear combination of atomic orbitals": [[26, "linear-combination-of-atomic-orbitals"]], "Ordering of atomic orbitals": [[26, "ordering-of-atomic-orbitals"]], "Overlap matrix": [[26, "overlap-matrix"], [113, "overlap-matrix"]], "Basis sets of atomic orbitals": [[26, "basis-sets-of-atomic-orbitals"]], "Assign to molecule": [[26, "assign-to-molecule"]], "Basis set library": [[26, "basis-set-library"]], "Number of basis functions": [[26, "number-of-basis-functions"]], "Additional information": [[26, "additional-information"]], "Rayleigh\u2013Schr\u00f6dinger perturbation theory": [[27, "rayleighschrodinger-perturbation-theory"]], "Solving the RSPT master equation": [[27, "solving-the-rspt-master-equation"]], "Numerical illustration": [[27, "numerical-illustration"]], "Size extensivity in RSPT": [[27, "size-extensivity-in-rspt"]], "Zeroth- and first-order energies": [[27, "zeroth-and-first-order-energies"]], "Second-order energy": [[27, "second-order-energy"]], "Reduced particle densities": [[28, "reduced-particle-densities"]], "Probabilistic interpretation": [[28, "probabilistic-interpretation"], [28, "id1"], [30, "probabilistic-interpretation"]], "Expectation values": [[28, "expectation-values"], [28, "id2"]], "One-particle density operator": [[28, "one-particle-density-operator"]], "Two-particle density operator": [[28, "two-particle-density-operator"]], "Second quantization": [[29, "second-quantization"]], "Fock space": [[29, "fock-space"]], "Creation and annihilation operators": [[29, "creation-and-annihilation-operators"]], "Ground state": [[29, "ground-state"], [46, "ground-state"], [59, "ground-state"]], "Slater determinants": [[29, "slater-determinants"], [30, "slater-determinants"]], "Illustration for Fock space F(4,10)": [[29, "illustration-for-fock-space-f-4-10"]], "Hamiltonian": [[29, "hamiltonian"]], "Energy": [[29, "energy"]], "One-electron term": [[29, "one-electron-term"]], "Two-electron term": [[29, "two-electron-term"]], "Many-electron wave functions": [[30, "many-electron-wave-functions"]], "Hilbert space of state vectors": [[30, "hilbert-space-of-state-vectors"]], "Pauli principle": [[30, "pauli-principle"]], "Unitary orbital transformations": [[30, "unitary-orbital-transformations"]], "Normalization": [[30, "normalization"]], "N-particle density": [[30, "n-particle-density"]], "Electron spin": [[31, "electron-spin"]], "Spin and Slater determinants": [[31, "spin-and-slater-determinants"]], "All determinants": [[31, "all-determinants"]], "High-spin determinants": [[31, "high-spin-determinants"]], "HOMO\u2013LUMO excited determinants": [[31, "homolumo-excited-determinants"]], "Wave function theory": [[32, "wave-function-theory"]], "Exercises": [[33, "exercises"], [70, "exercises"], [92, "exercises"], [126, "exercises"], [146, "exercises"], [131, "exercises"]], "Hartree-Fock": [[33, "hartree-fock"]], "One-particle density matrix": [[33, "one-particle-density-matrix"]], "Several states": [[33, "several-states"]], "Calculate the closed-shell MP2 energy correction": [[33, "calculate-the-closed-shell-mp2-energy-correction"]], "Calculate the MP2 amplitudes": [[33, "calculate-the-mp2-amplitudes"]], "Calculate the MP2 energy correction using the t amplitudes": [[33, "calculate-the-mp2-energy-correction-using-the-t-amplitudes"]], "O\u2013H dissociation potential energy curve": [[33, "o-h-dissociation-potential-energy-curve"]], "Dipole moment": [[33, "dipole-moment"], [39, "dipole-moment"]], "HF dipole moment": [[33, "hf-dipole-moment"]], "Unrelaxed MP2 dipole moment": [[33, "unrelaxed-mp2-dipole-moment"]], "Approximate relaxed MP2 dipole moment": [[33, "approximate-relaxed-mp2-dipole-moment"]], "Numerical HF and MP2 dipole moment": [[33, "numerical-hf-and-mp2-dipole-moment"]], "Ozone": [[33, "ozone"]], "Chromium dimer": [[33, "chromium-dimer"]], "CHELPG charges": [[34, "chelpg-charges"]], "Embedding potentials": [[35, "embedding-potentials"]], "ESP charges": [[36, "esp-charges"]], "Localized properties": [[37, "localized-properties"]], "LoProp charges and polarisabilities": [[38, "loprop-charges-and-polarisabilities"]], "Reference LoProp calculations": [[38, "reference-loprop-calculations"]], "LoProp transformation": [[38, "loprop-transformation"]], "T0: Atomic orbital rearrangement": [[38, "t0-atomic-orbital-rearrangement"]], "T1: Gram\u2013Schmidt orthogonalization of atomic blocks": [[38, "t1-gramschmidt-orthogonalization-of-atomic-blocks"]], "T2: L\u00f6dwin orthonormalization of occupied and virtual blocks": [[38, "t2-lodwin-orthonormalization-of-occupied-and-virtual-blocks"]], "T3: Occupied\u2013virtual projection": [[38, "t3-occupiedvirtual-projection"]], "T4: L\u00f6dwin orthogonalizatio of virtual blocks": [[38, "t4-lodwin-orthogonalizatio-of-virtual-blocks"]], "Localization of first-order properties": [[38, "localization-of-first-order-properties"]], "Localized charges": [[38, "localized-charges"]], "Localized dipole moments": [[38, "localized-dipole-moments"]], "Localization of second-order properties": [[38, "localization-of-second-order-properties"]], "Polarizabilities from response functions": [[38, "polarizabilities-from-response-functions"]], "Polarizabilities from perturbed density matrices": [[38, "polarizabilities-from-perturbed-density-matrices"]], "Localized polarizabilities": [[38, "localized-polarizabilities"]], "Non-polarizable embedding": [[39, "non-polarizable-embedding"]], "Gas phase water": [[39, "gas-phase-water"]], "SCF calculation": [[39, "scf-calculation"]], "Liquid water": [[39, "liquid-water"]], "Embedding operator": [[39, "embedding-operator"]], "Solvation energies": [[39, "solvation-energies"]], "Dipole moments": [[39, "dipole-moments"]], "Polarizable embedding": [[40, "polarizable-embedding"]], "RESP charges": [[41, "resp-charges"]], "Installation": [[42, "installation"]], "Conda installation": [[42, "conda-installation"]], "Faster conda solver": [[42, null]], "For Windows users": [[42, "for-windows-users"]], "Environment file": [[42, "environment-file"]], "If your notebook doesn\u2019t run": [[42, "if-your-notebook-doesn-t-run"]], "Compiling a local eChem book": [[42, "compiling-a-local-echem-book"]], "Getting started": [[43, "getting-started"]], "Our vision": [[43, "our-vision"]], "Who we are": [[43, "who-we-are"]], "Our software": [[43, "our-software"]], "VeloxChem": [[43, "veloxchem"]], "Gator": [[43, "gator"]], "Multi-Psi": [[43, "multi-psi"]], "Other tools": [[43, "other-tools"]], "geomeTRIC": [[43, "geometric"]], "xTB": [[43, "xtb"]], "OpenMM": [[43, "openmm"]], "py3Dmol": [[43, "py3dmol"]], "Open Babel": [[43, "open-babel"]], "Valet": [[43, "valet"]], "Conformer search": [[44, "conformer-search"]], "Conformer optimization": [[44, "conformer-optimization"]], "Choice of coordinates": [[45, "choice-of-coordinates"]], "Cartesian coordinates": [[45, "cartesian-coordinates"]], "Internal coordinates": [[45, "internal-coordinates"]], "Transforming between coordinate systems": [[45, "transforming-between-coordinate-systems"]], "Energy gradients": [[46, "energy-gradients"]], "Numerical Gradients": [[46, "numerical-gradients"]], "Analytical Gradients": [[46, "analytical-gradients"]], "HF": [[46, "hf"], [49, "hf"]], "Excited states": [[46, "excited-states"], [107, "excited-states"], [153, "excited-states"]], "CIS": [[46, "cis"]], "TDHF": [[46, "tdhf"]], "TDDFT": [[46, "tddft"], [124, "tddft"]], "Force fields": [[47, "force-fields"]], "Bonded terms": [[47, "bonded-terms"]], "Bond stretching": [[47, "bond-stretching"]], "Harmonic fit": [[47, "harmonic-fit"], [47, "id1"]], "Anharmonic fit": [[47, "anharmonic-fit"]], "Angle bending": [[47, "angle-bending"]], "Torsion": [[47, "torsion"]], "Non-bonded terms": [[47, "non-bonded-terms"]], "van der Waals interactions": [[47, "van-der-waals-interactions"]], "Electrostatic interaction": [[47, "electrostatic-interaction"]], "van der Waals interaction": [[47, "van-der-waals-interaction"]], "Additional terms": [[47, "additional-terms"]], "Gradients": [[48, "gradients"]], "Molecular Hessians": [[49, "molecular-hessians"]], "Numerical Hessians": [[49, "numerical-hessians"]], "Analytical Hessians": [[49, "analytical-hessians"]], "CPHF equations": [[49, "cphf-equations"]], "Perturbed density": [[49, "perturbed-density"]], "Second-order properties": [[49, "second-order-properties"]], "Hessians and vibrations": [[50, "hessians-and-vibrations"]], "PES interpolation techniques": [[51, "pes-interpolation-techniques"]], "Constructing the PES by interpolation": [[52, "constructing-the-pes-by-interpolation"]], "The ground state potential energy surface of water": [[52, "the-ground-state-potential-energy-surface-of-water"]], "Transforming from Cartesian to internal coordinates": [[52, "transforming-from-cartesian-to-internal-coordinates"]], "Ground-state PES by interpolation": [[52, "ground-state-pes-by-interpolation"]], "Molecular dynamics": [[53, "molecular-dynamics"]], "Running a simulation": [[54, "running-a-simulation"]], "Ensembles and time integration": [[55, "ensembles-and-time-integration"]], "Choice of ensemble": [[55, "choice-of-ensemble"]], "Microcanonical ensemble (NVE)": [[55, "microcanonical-ensemble-nve"]], "Canonical ensemble (NVT)": [[55, "canonical-ensemble-nvt"]], "Thermostat": [[55, "thermostat"]], "Isothermal-isobaric ensemble (NPT)": [[55, "isothermal-isobaric-ensemble-npt"]], "Barostat": [[55, "barostat"]], "Time integration": [[55, "time-integration"]], "Euler integration": [[55, "euler-integration"]], "Verlet integration": [[55, "verlet-integration"]], "Velocity Verlet": [[55, "velocity-verlet"]], "Structure optimization": [[57, "structure-optimization"]], "Constrained coordinates": [[58, "constrained-coordinates"]], "Set and freeze internal coordinates": [[58, "set-and-freeze-internal-coordinates"]], "Scan internal coordinates": [[58, "scan-internal-coordinates"]], "Larger molecules": [[59, "larger-molecules"]], "Optimization methods": [[60, "optimization-methods"]], "Gradient descent": [[60, "gradient-descent"]], "Conjugate gradient": [[60, "conjugate-gradient"]], "Newton\u2013Raphson": [[60, "newton-raphson"]], "Quasi-Newton": [[60, "quasi-newton"]], "Note": [[60, null]], "Property gradients": [[61, "property-gradients"]], "IR intensities": [[61, "ir-intensities"]], "Raman intensities": [[61, "raman-intensities"]], "Reparameterize force fields": [[62, "reparameterize-force-fields"]], "Dihedral angles": [[62, "dihedral-angles"]], "GAFF force field": [[62, "gaff-force-field"]], "Fitting to QM potential": [[62, "fitting-to-qm-potential"]], "Weighted fitting": [[62, "weighted-fitting"]], "Excluding tricky angles": [[62, "excluding-tricky-angles"]], "Molecular symmetry": [[63, "molecular-symmetry"]], "Transition-state theory": [[64, "transition-state-theory"]], "Transition state": [[65, "transition-state"]], "IRC method": [[65, "irc-method"]], "Importing modules": [[65, "importing-modules"]], "Visualization of the molecule": [[65, "visualization-of-the-molecule"]], "Finding the Transition State": [[65, "finding-the-transition-state"]], "Setting up the SCF driver": [[65, "setting-up-the-scf-driver"]], "Setting up the gradient driver": [[65, "setting-up-the-gradient-driver"]], "Setting up the optimization driver": [[65, "setting-up-the-optimization-driver"]], "Visualization of the TS frequencies": [[65, "visualization-of-the-ts-frequencies"]], "Calculation of the activation free energy": [[65, "calculation-of-the-activation-free-energy"]], "Comparing reactant and transition state": [[65, "comparing-reactant-and-transition-state"]], "Finding the product": [[65, "finding-the-product"]], "Minimizing the structure to product: going forward the IRC path": [[65, "minimizing-the-structure-to-product-going-forward-the-irc-path"]], "Vibrational analysis": [[66, "vibrational-analysis"], [131, "vibrational-analysis"]], "Cartesian and mass-weighted Hessian": [[66, "cartesian-and-mass-weighted-hessian"]], "Translating and rotating frame": [[66, "translating-and-rotating-frame"]], "Hessian in internal coordinates and harmonic frequencies": [[66, "hessian-in-internal-coordinates-and-harmonic-frequencies"]], "Cartesian displacements, reduced masses, and force constants": [[66, "cartesian-displacements-reduced-masses-and-force-constants"]], "References": [[67, "references"]], "Algebraic-diagrammatic construction": [[68, "algebraic-diagrammatic-construction"]], "Core-valence separation": [[69, "core-valence-separation"], [106, "core-valence-separation"]], "ADC summary": [[70, "adc-summary"]], "ISR for ADC(0) and ADC(1)": [[70, "isr-for-adc-0-and-adc-1"]], "Step 1. Calculate the reference state": [[70, "step-1-calculate-the-reference-state"]], "Step 2. Construct the ADC(0) and ADC(1) matrices": [[70, "step-2-construct-the-adc-0-and-adc-1-matrices"]], "Step 3. Diagonalize the ADC matrix": [[70, "step-3-diagonalize-the-adc-matrix"]], "The absorption spectrum": [[70, "the-absorption-spectrum"]], "Excited state analysis": [[70, "excited-state-analysis"]], "Attachment and detachment densities": [[70, "attachment-and-detachment-densities"], [153, "attachment-and-detachment-densities"]], "Promotion numbers": [[70, "promotion-numbers"]], "HPC-QC implementation": [[71, "hpc-qc-implementation"]], "Intermediate state representation": [[72, "intermediate-state-representation"]], "Derivation via intermediate states": [[72, "derivation-via-intermediate-states"]], "Structure of the ADC matrix": [[72, "structure-of-the-adc-matrix"]], "Explicit expressions for ADC(2)": [[72, "explicit-expressions-for-adc-2"]], "Comparison to related methods": [[72, "comparison-to-related-methods"]], "Excited-state properties": [[72, "excited-state-properties"]], "Calculate HF reference states": [[72, "calculate-hf-reference-states"]], "Excitation energies of individual systems": [[72, "excitation-energies-of-individual-systems"]], "Composite system": [[72, "composite-system"]], "Polarization propagator": [[73, "polarization-propagator"]], "Birefringences and dichroisms": [[74, "birefringences-and-dichroisms"]], "Linear birefringence": [[74, "linear-birefringence"]], "Circular birefringence": [[74, "circular-birefringence"]], "Axial birefringence": [[74, "axial-birefringence"]], "Full-CI response": [[75, "full-ci-response"]], "Cubic response": [[76, "cubic-response"]], "Second-order electric-dipole hyperpolarizability": [[76, "second-order-electric-dipole-hyperpolarizability"]], "Pertinent optical processes": [[76, "pertinent-optical-processes"], [98, "pertinent-optical-processes"]], "Isotropic quantities": [[76, "isotropic-quantities"]], "Dispersion": [[76, "dispersion"], [98, "dispersion"], [99, "dispersion"]], "In VeloxChem": [[76, "in-veloxchem"], [89, "in-veloxchem"], [98, "in-veloxchem"]], "Dichroism": [[77, "dichroism"]], "Dipole equivalence relations": [[78, "dipole-equivalence-relations"]], "Electronic and nuclear contributions": [[79, "electronic-and-nuclear-contributions"]], "Exciton coupling model": [[80, "exciton-coupling-model"]], "Subsystems and states": [[80, "subsystems-and-states"]], "Energies and couplings": [[80, "energies-and-couplings"]], "Example": [[81, "example"]], "Import modules": [[81, "import-modules"]], "Set up molecule and basis set": [[81, "set-up-molecule-and-basis-set"]], "Set up the exciton model driver": [[81, "set-up-the-exciton-model-driver"]], "Initializes exciton model Hamiltonian and transition dipoles": [[81, "initializes-exciton-model-hamiltonian-and-transition-dipoles"]], "Run monomer calculations": [[81, "run-monomer-calculations"]], "Run dimer calculations": [[81, "run-dimer-calculations"]], "Print the exciton model Hamiltonian": [[81, "print-the-exciton-model-hamiltonian"]], "Get excitation energies and transition dipoles": [[81, "get-excitation-energies-and-transition-dipoles"]], "Plot absorption and ECD spectra": [[81, "plot-absorption-and-ecd-spectra"]], "Experiment to theory": [[82, "experiment-to-theory"]], "Isotropic molecular orientation": [[82, "isotropic-molecular-orientation"]], "Laboratory and molecular frames": [[82, "laboratory-and-molecular-frames"]], "Rotational averages": [[82, "rotational-averages"]], "Fields and polarization": [[82, "fields-and-polarization"]], "Linear polarization": [[82, "linear-polarization"]], "Circular polarization": [[82, "circular-polarization"]], "Field strengths and intensities": [[82, "field-strengths-and-intensities"]], "Spatial averaging of high order properties": [[82, "spatial-averaging-of-high-order-properties"]], "Formulae for rank two to rank five tensor properties": [[82, "formulae-for-rank-two-to-rank-five-tensor-properties"]], "Example of application: electric dipole polarizability": [[82, "example-of-application-electric-dipole-polarizability"]], "Example of application: quadrupolar contributions": [[82, "example-of-application-quadrupolar-contributions"]], "Linear response": [[82, "linear-response"], [90, "linear-response"], [109, "linear-response"]], "Quadratic response": [[82, "quadratic-response"], [98, "quadratic-response"]], "Finite field method": [[83, "finite-field-method"]], "Energy expansion": [[83, "energy-expansion"]], "Dipole moment expansion": [[83, "dipole-moment-expansion"]], "Polarizability expansion": [[83, "polarizability-expansion"]], "Hyperpolarizability expansion": [[83, "hyperpolarizability-expansion"]], "Numerical example": [[83, "numerical-example"]], "Numerical differentiation": [[83, "numerical-differentiation"]], "Field-dependent molecular properties": [[83, "field-dependent-molecular-properties"]], "Calculate derivatives": [[83, "calculate-derivatives"]], "Results": [[83, "results"]], "Electric multipole moments": [[84, "electric-multipole-moments"]], "Dipole and quadrupole moments": [[84, "dipole-and-quadrupole-moments"]], "Quasi-energy determination of parameters": [[87, "quasi-energy-determination-of-parameters"]], "Linear Response": [[89, "linear-response"]], "Electric-dipole polarizability": [[89, "electric-dipole-polarizability"], [113, "electric-dipole-polarizability"]], "Significance": [[89, "significance"]], "Isotropic and anisotropic components": [[89, "isotropic-and-anisotropic-components"]], "Measurements": [[89, "measurements"]], "High-accuracy results": [[89, "high-accuracy-results"]], "Basis set requirements": [[89, "basis-set-requirements"]], "Cauchy moment expansion": [[89, "cauchy-moment-expansion"]], "Real response function": [[89, "real-response-function"]], "Complex response function": [[89, "complex-response-function"]], "Concept": [[90, "concept"]], "Illustrative calculations": [[90, "illustrative-calculations"]], "Molecular properties": [[91, "molecular-properties"]], "Static fields": [[91, "static-fields"]], "Time-dependent fields": [[91, "time-dependent-fields"]], "Response theory": [[91, "response-theory"], [111, "response-theory"]], "Tensor properties": [[91, "tensor-properties"]], "Electric properties": [[91, "electric-properties"]], "Dioxetane chemiluminescence": [[92, "dioxetane-chemiluminescence"]], "Natural transition orbitals": [[94, "natural-transition-orbitals"], [153, "natural-transition-orbitals"]], "Visualization": [[94, "visualization"], [136, "visualization"]], "UV/vis absorption": [[95, "uv-vis-absorption"]], "Field-dependence of parameters": [[96, "field-dependence-of-parameters"]], "Orbital rotations": [[97, "orbital-rotations"]], "Reference state parameterization": [[97, "reference-state-parameterization"]], "Generator of orbital rotations": [[97, "generator-of-orbital-rotations"]], "Phase isolation": [[97, "phase-isolation"], [97, "id1"]], "Spin symmetry": [[97, "spin-symmetry"], [97, "id2"]], "Illustrations": [[97, "illustrations"]], "Multi-electron excited determinants": [[97, "multi-electron-excited-determinants"]], "First-order electric-dipole hyperpolarizability": [[98, "first-order-electric-dipole-hyperpolarizability"]], "Symmetry aspects": [[98, "symmetry-aspects"]], "Response functions": [[99, "response-functions"], [88, "response-functions"]], "Responses to external fields": [[99, "responses-to-external-fields"]], "Defining the system": [[99, "defining-the-system"]], "Time propagation": [[99, "time-propagation"], [99, "id2"]], "Two-level system": [[99, "two-level-system"]], "Plotting observables": [[99, "plotting-observables"]], "Determining response functions": [[99, "determining-response-functions"]], "Analytic response functions": [[99, "analytic-response-functions"]], "Poles of response functions": [[99, "poles-of-response-functions"]], "Rovibronic states": [[100, "rovibronic-states"]], "Rotational Schr\u00f6dinger equation": [[100, "rotational-schrodinger-equation"]], "Numerov\u2019s method and the vibrational Schr\u00f6dinger equation": [[100, "numerov-s-method-and-the-vibrational-schrodinger-equation"]], "Numerov\u2019s method in VeloxChem": [[100, "numerov-s-method-in-veloxchem"]], "Rovibrational spectra": [[100, "rovibrational-spectra"]], "Vibronic transitions": [[100, "vibronic-transitions"]], "User defined potential": [[100, "user-defined-potential"]], "State-averaged MCSCF": [[101, "state-averaged-mcscf"]], "CASCI response": [[101, "casci-response"]], "State-specific optimization": [[101, "state-specific-optimization"]], "State-averaging": [[101, "state-averaging"]], "Selection rules": [[102, "selection-rules"]], "Time-dependent DFT": [[104, "time-dependent-dft"]], "Charge transfer": [[105, "charge-transfer"]], "Full-space results": [[106, "full-space-results"], [148, "full-space-results"]], "CVS-space results": [[106, "cvs-space-results"], [148, "cvs-space-results"]], "From VeloxChem": [[106, "from-veloxchem"]], "Comparison": [[106, "comparison"], [139, "comparison"], [148, "comparison"]], "Foundations": [[108, "foundations"]], "Runge-Gross theorem": [[108, "runge-gross-theorem"]], "Adiabatic approximation": [[108, "adiabatic-approximation"]], "In SCF theory": [[111, "in-scf-theory"]], "Quasi-energy": [[112, "quasi-energy"]], "RPA equation": [[113, "rpa-equation"]], "Eigenstates": [[113, "eigenstates"]], "Electronic Hessian": [[113, "electronic-hessian"], [86, "electronic-hessian"]], "Property gradient": [[113, "property-gradient"], [86, "property-gradient"]], "Excitation energies": [[113, "excitation-energies"]], "Intensities": [[113, "intensities"]], "Analysis": [[113, "analysis"], [125, "analysis"]], "Complex polarizability": [[113, "complex-polarizability"]], "Spin-flip": [[114, "spin-flip"]], "Tamm\u2013Dancoff approximation": [[115, "tammdancoff-approximation"]], "Triplet instability": [[116, "triplet-instability"]], "Two-photon absorption": [[117, "two-photon-absorption"]], "Wave function methods": [[118, "wave-function-methods"]], "
    Computational Chemistry from Laptop to HPC
    ": [[119, "computational-chemistry-from-laptop-to-hpc"]], "Static versus dynamic correlation correlation": [[120, "static-versus-dynamic-correlation-correlation"]], "Bond-breaking": [[120, "bond-breaking"]], "At equilibrium distance": [[120, "at-equilibrium-distance"]], "Open shells": [[121, "open-shells"]], "Restricted versus unrestricted": [[122, "restricted-versus-unrestricted"]], "High spin states": [[122, "high-spin-states"]], "Single-reference methods": [[122, "single-reference-methods"]], "Multi-reference methods": [[122, "multi-reference-methods"]], "Low spin states": [[122, "low-spin-states"]], "Single-reference methods: broken symmetry": [[122, "single-reference-methods-broken-symmetry"]], "Multi-reference solution": [[122, "multi-reference-solution"]], "UV/vis spectroscopies": [[123, "uv-vis-spectroscopies"]], "Absorption": [[124, "absorption"]], "CPP-DFT": [[124, "cpp-dft"], [145, "cpp-dft"]], "ADC": [[124, "adc"], [145, "adc"]], "CPP-ADC": [[124, "cpp-adc"]], "Comparison of spectra": [[124, "comparison-of-spectra"]], "Print and plot spectra": [[125, "print-and-plot-spectra"]], "Dominant contributions to eigenstates": [[125, "dominant-contributions-to-eigenstates"]], "Polarization dependence": [[125, "polarization-dependence"], [142, "polarization-dependence"]], "Spectrum calculation and assignment": [[126, "spectrum-calculation-and-assignment"]], "Cost-saving measures": [[126, "cost-saving-measures"], [147, "cost-saving-measures"]], "Fluorescence": [[127, "fluorescence"]], "Recommendations": [[128, "recommendations"], [149, "recommendations"]], "Electronic structure model": [[128, "electronic-structure-model"]], "Basis set selection": [[128, "basis-set-selection"], [149, "basis-set-selection"]], "Vibrational spectroscopies": [[129, "vibrational-spectroscopies"]], "IR spectroscopy": [[130, "ir-spectroscopy"]], "Raman spectroscopy": [[132, "raman-spectroscopy"]], "Spectrum calculation": [[132, "spectrum-calculation"], [144, "spectrum-calculation"]], "Building systems": [[133, "building-systems"]], "Using SMILES": [[133, "using-smiles"]], "Bond type": [[133, "bond-type"]], "Branching and substitutions": [[133, "branching-and-substitutions"]], "Optimization using force field": [[133, "optimization-using-force-field"]], "Ring systems": [[133, "ring-systems"]], "More complex systems": [[133, "more-complex-systems"]], "Using a structure downloaded from the PDB databank": [[133, "using-a-structure-downloaded-from-the-pdb-databank"]], "Assembling a full workflow": [[134, "assembling-a-full-workflow"]], "Global warming potential": [[135, "global-warming-potential"]], "Methane combustion energy": [[136, "methane-combustion-energy"]], "Geometry optimization": [[136, "geometry-optimization"], [156, "geometry-optimization"]], "Force field optimization": [[136, "force-field-optimization"]], "xTB optimization": [[136, "xtb-optimization"], [139, "xtb-optimization"]], "Energy calculation": [[136, "energy-calculation"]], "Reaction energy": [[136, "reaction-energy"]], "Optimizing electronic structure": [[137, "optimizing-electronic-structure"]], "Specify structure": [[137, "specify-structure"]], "KS-DFT optimization": [[137, "ks-dft-optimization"]], "From structure to spectrum": [[138, "from-structure-to-spectrum"]], "Optimizing molecular structure": [[139, "optimizing-molecular-structure"]], "Initial structure": [[139, "initial-structure"]], "HF optimization": [[139, "hf-optimization"]], "Constructing workflows": [[140, "constructing-workflows"]], "X-ray spectroscopies": [[141, "x-ray-spectroscopies"]], "Spectrum analysis": [[142, "spectrum-analysis"]], "Looking at solution vectors": [[142, "looking-at-solution-vectors"]], "Eigenvectors": [[142, "eigenvectors"]], "Decomposition of spectra": [[142, "decomposition-of-spectra"]], "Atomic contributions": [[142, "atomic-contributions"]], "Special aspects": [[143, "special-aspects"]], "Relaxation": [[143, "relaxation"]], "Relaxation of core-ionized systems": [[143, "relaxation-of-core-ionized-systems"]], "Relaxation of core-(de)excitation": [[143, "relaxation-of-core-de-excitation"]], "Including relaxation with \\DeltaSCF methods": [[143, "including-relaxation-with-deltascf-methods"]], "Including relaxation with wave-function methods": [[143, "including-relaxation-with-wave-function-methods"]], "Including relaxation with DFT-based methods": [[143, "including-relaxation-with-dft-based-methods"]], "Relativity": [[143, "relativity"]], "Scalar relativistic effects": [[143, "scalar-relativistic-effects"]], "Spin-orbit coupling": [[143, "spin-orbit-coupling"]], "Basis set considerations": [[143, "basis-set-considerations"]], "Self-interaction error in DFT": [[143, "self-interaction-error-in-dft"]], "Core-hole localization": [[143, "core-hole-localization"]], "Tailored CVS": [[143, "tailored-cvs"]], "Post-HF on a non-Aufbau reference": [[143, "post-hf-on-a-non-aufbau-reference"]], "Spurious valence mixing in XAS": [[143, "spurious-valence-mixing-in-xas"]], "X-ray photoemission spectroscopy": [[144, "x-ray-photoemission-spectroscopy"]], "IEs from Koopmans\u2019 theorem": [[144, "ies-from-koopmans-theorem"]], "The maximum overlap method": [[144, "the-maximum-overlap-method"]], "IEs from \\DeltaSCF": [[144, "ies-from-deltascf"]], "Spectra from \\Delta\\textrm{SCF}": [[144, "spectra-from-delta-textrm-scf"]], "X-ray absorption spectroscopy": [[144, "x-ray-absorption-spectroscopy"]], "Decoupling from the valence continuum": [[144, "decoupling-from-the-valence-continuum"]], "Spectra from CVS-ADC": [[144, "spectra-from-cvs-adc"]], "Spectra from TDDFT": [[144, "spectra-from-tddft"], [144, "sec-xray-calc-xesdft"]], "Spectra from CPP-DFT": [[144, "spectra-from-cpp-dft"]], "Spectra from CPP-CASSCF": [[144, "spectra-from-cpp-casscf"]], "X-ray emission spectroscopy": [[144, "x-ray-emission-spectroscopy"]], "Spectra from ADC": [[144, "spectra-from-adc"]], "Spectra from ground state MOs": [[144, "spectra-from-ground-state-mos"]], "Resonant inelastic X-ray scattering": [[144, "resonant-inelastic-x-ray-scattering"]], "Two-step approach with ADC": [[144, "two-step-approach-with-adc"]], "Cheat sheet": [[145, "cheat-sheet"]], "Typical workflow": [[145, "typical-workflow"]], "IEs and XPS": [[145, "ies-and-xps"]], "Koopmans\u2019 theorem": [[145, "koopmans-theorem"]], "\\Delta-methods": [[145, "delta-methods"]], "XAS": [[145, "xas"]], "CVS-ADC": [[145, "cvs-adc"]], "XES": [[145, "xes"]], "Ground state MOs": [[145, "ground-state-mos"]], "Chemical shifts": [[146, "chemical-shifts"]], "Basis set augmentation": [[146, "basis-set-augmentation"], [146, "id1"]], "Ground-state model for XAS": [[146, "ground-state-model-for-xas"], [146, "id2"]], "The Tamm-Dancoff approximation": [[146, "the-tamm-dancoff-approximation"], [146, "id3"]], "Solutions": [[146, "solutions"]], "Chemical shift": [[146, "chemical-shift"]], "Larger systems": [[147, "larger-systems"]], "Valence-to-core XES": [[147, "valence-to-core-xes"]], "XAS of solvated systems": [[147, "xas-of-solvated-systems"]], "Uracil with CVS-ADC(2)-x": [[147, "uracil-with-cvs-adc-2-x"]], "Phthalocyanine with TDDFT": [[147, "phthalocyanine-with-tddft"]], "XES of solvated systems": [[147, "xes-of-solvated-systems"]], "Uracil with ADC(2)": [[147, "uracil-with-adc-2"]], "Phthalocyanine with DFT": [[147, "phthalocyanine-with-dft"]], "Coupling to molecular dynamics": [[147, "coupling-to-molecular-dynamics"]], "Non-standard calculations": [[148, "non-standard-calculations"]], "Transient X-ray absorption spectroscopy": [[148, "transient-x-ray-absorption-spectroscopy"]], "Valence-excited reference state": [[148, "valence-excited-reference-state"]], "Coupling valence- and core-excited eigenstates": [[148, "coupling-valence-and-core-excited-eigenstates"]], "Impact of channel restriction for TDDFT": [[148, "impact-of-channel-restriction-for-tddft"]], "Ionization energies from XAS": [[148, "ionization-energies-from-xas"]], "Ionization energies from XES": [[148, "ionization-energies-from-xes"]], "XES considered in reverse": [[148, "xes-considered-in-reverse"]], "Precision versus accuracy": [[149, "precision-versus-accuracy"]], "Electronic stucture method": [[149, "electronic-stucture-method"]], "Relativistic effects": [[149, "relativistic-effects"]], "Units and notation": [[150, "units-and-notation"]], "Atomic units": [[150, "atomic-units"]], "Unit conversion": [[150, "unit-conversion"]], "Notation": [[150, "notation"]], "Orbitals and wave functions": [[150, "orbitals-and-wave-functions"]], "Indices": [[150, "indices"]], "Matrices and vectors": [[150, "matrices-and-vectors"]], "Common matrices": [[150, "common-matrices"]], "Consistency of notation": [[150, "consistency-of-notation"]], "Short-hand notation": [[150, "short-hand-notation"]], "Spectrum broadening": [[151, "spectrum-broadening"]], "Broadening in experiment": [[151, "broadening-in-experiment"]], "Lorentzian": [[151, "lorentzian"]], "Gaussian": [[151, "gaussian"]], "Voigt": [[151, "voigt"]], "Broadening calculated spectrum": [[151, "broadening-calculated-spectrum"]], "Visual analysis of electronic transitions": [[153, "visual-analysis-of-electronic-transitions"]], "MD trajectories": [[154, "md-trajectories"]], "Molecular structure and dynamics": [[155, "molecular-structure-and-dynamics"]], "Optimization and normal modes": [[156, "optimization-and-normal-modes"]], "Vibrational normal modes": [[156, "vibrational-normal-modes"]], "Orbitals and densities": [[157, "orbitals-and-densities"]], "Using OrbitalViewer": [[157, "using-orbitalviewer"]], "Using cube-files": [[157, "using-cube-files"]], "Radial distribution": [[157, "radial-distribution"]], "Valence orbitals": [[157, "valence-orbitals"]], "Atomic sub-shell densities": [[157, "atomic-sub-shell-densities"]], "Spectra and properties": [[158, "spectra-and-properties"]], "Time-dependence of observables": [[88, "time-dependence-of-observables"]], "Representing a monochromatic electric field": [[88, null]], "Perturbation expansions": [[88, "perturbation-expansions"]], "Spin-adapted electron transfer operators": [[88, null]], "Expectation values of observables": [[88, "expectation-values-of-observables"]], "Spin-adapted electron transfer operators in VeloxChem": [[88, "spin-adapted-excitation-operators"]], "Energy determination of parameters": [[86, "energy-determination-of-parameters"]], "Order expansion of parameters": [[86, "order-expansion-of-parameters"]], "Linear response equation": [[86, "linear-response-equation"]], "Baker\u2013Campbell\u2013Hausdorff expansion": [[86, "bakercampbellhausdorff-expansion"]], "Spin-adapted excitation operators": [[86, "spin-adapted-excitation-operators"]], "Setup": [[86, "setup"]], "Response vector": [[86, "response-vector"]], "Response function": [[86, "response-function"]], "SCF geometry optimization": [[131, "scf-geometry-optimization"]], "Hessians": [[131, "hessians"]], "IR intensities and Raman activities": [[131, "ir-intensities-and-raman-activities"]]}, "indexentries": {}}) \ No newline at end of file