Release Notes¶
InQuanto 5.1.1¶
16 October 2025
Bug Fixes
Fixed submission to
qnexusbackends when usingIterativePhaseEstimationQuantinuum
InQuanto 5.1.0¶
12 September 2025
Features
Add
MultiConfigurationAnsatzSparseandMultiConfigurationStateSparsefor efficient preparation of sparse linear combinations of basis states based on Gleinig and Hoefler’s 2021 IEEE paperAdd symmetrized (
FermionSpaceAnsatzsUPS) and tiled (FermionSpaceAnsatztUPS) unitary product state ansatzes based on work by Burton et al. and Burton H., G., A. respectivelyAdd
MinimizerBasinHoppingas implemented in SciPyAdd module (
qec_qpe_chem) that allows users to replicate some of the work in the Quantum Error-Corrected Computation of Molecular Energies pre-print
Bug Fixes
Make
QubitOperatorList.from_list()error when given incorrect input
InQuanto 5.0.0¶
23 June 2025
Decouple major InQuanto versioning (i.e. API-breaking changes) from full-feature releases
Make InQuanto codebase mypy compatible
Remove sourcedefender dependency
Releases now delivered as Cythonized wheels
Remove the
OccupationSpace.select()method
Features
Averaging protocols built with state vector backends can now sample the exact distribution of outcomes by passing
shots_per_circuit=NoneReplaced the
DriverGeneralizedHubbardclass with extendedDriverGeneralizedHubbard1DandDriverGeneralizedHubbard2Dclasses
Bug Fixes
Fix issue with circuit hashing due to changes in pytket v2.5
Move box decomposition of
MultiConfigurationStateto the compilation stepClarify the default use of point group symmetries in
FermionSpaceFix asynchronous
protocol.launch()andprotocol.retrieve()for local-running pytket backendsMake
run_mitex()use state circuitsMake
evaluate_expectation_uvalue()handle kernels with complex coefficients; either raising an error or casting to a real value if possible.The two body iterator of chemistry operators no longer yields duplicate terms, however it will yield terms with equal but oppositely ordered annihilation operators. Calling the
to_FermionOperator()method now combines these terms (i.e. pairs ofFermionOperatorStringwith oppositely ordered annihilation operators) and returns a normal orderedFermionOperatorwith largest indices first.
InQuanto-PySCF 2.1.0¶
23 June 2025
Remove sourcedefender dependency
Releases now delivered as Cythonized wheels
InQuanto-NGLView 0.10.0¶
23 June 2025
Remove sourcedefender dependency
Releases now delivered as Cythonized wheels
InQuanto-Phayes 0.4.0¶
23 June 2025
Remove sourcedefender dependency
Releases now delivered as Cythonized wheels
InQuanto-Nexus 1.1.0¶
23 June 2025
Remove sourcedefender dependency
Releases now delivered as Cythonized wheels
InQuanto-cuTensorNet 0.1.0¶
24 June 2025
Remove sourcedefender dependency
Releases now delivered as Cythonized wheels
InQuanto 4.3.5¶
9 May 2025
Hotfix: flattening further cases of state vector arrays in operators
InQuanto 4.3.4¶
7 May 2025
Hotfix: flattening further cases of state vector arrays in ansatzes
InQuanto 4.3.3¶
30 April 2025
Hotfix: flattening shape of state vector arrays due to adoption of nanobind in pytket >v2.3
InQuanto 4.3.2¶
23 April 2025
Hotfix: upgraded SourceDefender dependency to v15.0. Note all extensions also update to match this dependency version.
Compatibility updates for pytket v2, qnexus, pytket-qiskit, and numpy v2
InQuanto 4.3.1¶
17 March 2025
Hotfix: default qiskit-ibm-runtime optional dependency to versions less than v0.37 due to qiskit
PulseBackendConfigurationissue.
InQuanto 4.3.0¶
13 March 2025
Protocol
.launch()and.retrieve()methods now return ExecuteJobRef handles allowing asynchronous workflows with qnexus backends.
InQuanto 4.2.0¶
13 February 2025
Expanded pickle-ability of protocols (e.g. iterative QPE)
dumps()andloads()Added from_fcidump method for spin-unrestricted operators
from_fcidump()Added the SymbolEnsemble class to documentation
SymbolEnsembleMinimizer iterations and function (objective, gradient, aux) calls are now consistently annotated in e.g.
generate_report()Bug fixes
Fixed numpy overflow issue for more than 63 qubit ansatz construction
Enabled the use of
run_vqe()with qnexus statevector configurationsFixed bug in algorithm reporting for averaging of empty lists
Now append username (uuid) to inquanto generated log files to prevent races
InQuanto 4.1.0¶
17 December 2024
Added preoptimize_passes to
SparseStatevectorProtocolto address ansatz inconsistencies from v4 refactor.Fix for
PMSVdue to changes in tket’s opgroup labelling.
InQuanto 4.0.1¶
28 November 2024
Improved statevector caching performance.
InQuanto 4.0.0¶
19 November 2024
General changes
InQuanto API is now standardiZed to use American English spelling (optimiZe, diagonaliZe, etc.).
[
SymbolDict] and [SymbolSet] have been replaced with Python dictionaries. This is most noticeable in ansatz and protocols, for exampleto_dictandfrom_dictmethods have been removed.Two new extensions: inquanto-nexus and inquanto-cutensornet
InQuanto now supports Numpy v2+, along with other related dependency updates.
Default numerical tolerances are now defined only in
core.
Protocols have had a major refactor to enable better interaction with circuit compilation using tket passes. See e.g.
compile_circuits()and the protocols manual.Circuit protocols must now explicitly be compiled. Therefore the circuit protocol workflow involves: instancing, building, compiling, running, and evaluation.
buildmethods now creates the set of uncompiled measurement circuits.We recommend
compile_circuitsas the only place to apply circuit compression, and therefore some implicit pytket passes which were applied in (e.g.) ansatz construction are now carried to the protocol aspreoptimize_passesBecause of the above, state circuits contained in ansatz classes may contain undecomposed circuit boxes. Therefore, certain metrics of the ansatz (such as from using ansatz.state_circuit.n_2qb_gates) may not accurately reflect the final circuits in the protocol.
SPAM
calibrate()method now has an option to be performed asynchronously, to manage job delivery.HadamardTestDerivativehas been refactored for easier computation of real, imaginary, or complex components.Statevector protocols have been refactored to generalize for tensor network based protocols. Use of hashing has been made more efficient.
Modified protocols to allow Quantinuum Nexus client instances through the inquanto-nexus extension.
Operators
Operator mappings are now performed using C++ routines.
Added
FCIDumpRestrictedandFCIDumpUnrestrictedfor importing systems from other chemistry codes.Double factorization classes have been refactored.
Added double factorization for unrestricted-spin systems (see double_factorization_h3.py in examples)
double_factorize().Added ‘core tensor’ method for double factorization
XDFCoreTensor
InQuanto’s
QubitOperatorhas been fully separated from pytket’s QubitPauliOperator (see: pytket docs).
Ansatzes
Added
unsympify()to convert from sympy to floats to avoid symbolic circuit submission. For example it will replace instances of sympy.pi with float(3.14..).Improved performance of ansatz hashing and comparison operations.
to_QubitState()uses efficient implementation by default.State circuits contained in ansatz classes may now contain undecomposed circuit boxes.
As such, approximate state resource estimation should be performed with
circuit_resources()SHSV problem is solved.
InQuanto-PySCF 2.0.0¶
19 November 2024
[
SymbolDict] and [SymbolSet] have been replaced with Python dictionaries.API is now standardiZed to use American English spellings of words.
Added an example for computing oscillator strengths between VQE ground states and VQD excited states.
Performance improvements through better use of numpy.einsum and in-memory pyscf ao2mo usage.
InQuanto-NGLView 0.8.0¶
19 November 2024
API is now standardiZed to use American English spelling.
Update pint version dependency due to
numpycompatibility.
InQuanto-Phayes 0.3.0¶
19 November 2024
Align dependencies with other packages.
InQuanto-Nexus 0.1.0¶
19 November 2024
Added support for the Quantinuum Nexus client for storing and managing projects, and compilation and execution jobs.
See documentation on Nexus usage (see: InQuanto-Nexus and Quantinuum nexus ).
InQuanto-cuTensorNet 0.0.0¶
19 November 2024
Created
CuTensorNetProtocolfor performing state-vector and shot emulation using the pytket-cutensornet backend.See examples.
InQuanto 3.7.0¶
22 October 2024
Added asynchronous calibration to
SPAMso hardware delivery is controllableLicensing modified for improved Quantinuum Nexus usage
InQuanto 3.6.1¶
3 September 2024
Add
QCM4Computablecomputable for quantum computed moments up to the 4th orderMake remaining protocol classes compatible with
ProtocolListby addingbuild_protocols_from()method definitionsNew examples for the factorized overlap protocol classes (e.g.
FactorizedOverlap) with comparisons toHadamardTestOverlapImprove the information given in the dataframe outputted by protocols using the
dataframe_circuit_shot()functionAdd
to_QubitPauliString(),from_QubitPauliString()methods toQubitOperatorStringclass, andto_QubitPauliOperator(), andfrom_QubitPauliOperator()methods to theQubitOperatorclass to allow the conversion ofQubitOperatorto/from the pytket accessiblepytket.utils.QubitPauliOperatorAdd
all_nontrivial_qubits()property toQubitOperator,QubitOperatorString, andQubitOperatorListclassesInQuanto now throws a warning when there are dependency conflicts or required upgrades
Ensured calls to
numpy.einsumcorrectly scale via optimize keyword argumentMake InQuanto installable with poetry
Bug fixes:
Fixed
load_xyz()defaulting to Geometry base class when calledFix bug where integer type parameters could cause unwarranted rounding of non-integer quantities giving incorrect results
InQuanto 3.5.8¶
23 August 2024
Hotfix release latest pytket version
InQuanto 3.5.7¶
2 August 2024
Hotfix pytket v1.31 dependency issues
InQuanto 3.5.6¶
10 July 2024
Hotfix sympy v1.13 dependency issues
InQuanto 3.5.5¶
4 June 2024
Upgraded Zeus dependency to v0.0.1b6
InQuanto 3.5.4¶
13 May 2024
Upgraded Sourcedefender dependency to v14.0
InQuanto 3.5.3¶
10 May 2024
Upgraded Sourcedefender dependency to v13.0
InQuanto 3.5.2¶
10 May 2024
Upgraded Sourcedefender dependency to v12.0
InQuanto 3.5.1¶
07 May 2024
Resolved scipy dependency conflict.
Bug fixes:
Fixed a slowdown in qubit mappings caused in 3.5.0. Mapping speed should now be consistent with InQuanto versions <3.5.0.
qubit_encode()for integral operators now takes thequbitsargument, allowingQubitMappingBravyiKitaevsupport.
InQuanto 3.5.0¶
24 April 2024
Introducing new protocols:
ComputeUncomputeFactorizedOverlapandSwapFactorizedOverlapfor computing complex overlaps.Expanded
ProtocolListsupport to the following averaging protocols:End-to-end runners for averaging protocols now support symbolic compilation with the
compile_symbolicargument (seeget_runner()).Protocols now allow control over pytket
optimisation_levelarg at thebuild()step.Updated pandas dependency to version 2.2.
Added the
qubit_encode()method forFermionStateandFermionStateString.Bug fix: The
complex_typearg inHadamardTestDerivativenow supports string input.
InQuanto 3.4.2¶
11 April 2024
Update examples algorithm_vqe_varCI.py and algorithm_vqe_varCI_h3p.py to use up-to-date
MultiConfigurationAnsatzAPIBug fixes:
Corrected Qiskit API usage in
get_noisy_backend()PMSVinput symmetry validation is now more robustFixed
symbol_substitution()inFermionSpaceAnsatzChemicallyAwareUCCSD
InQuanto 3.4.1¶
08 March 2024
Upgrade Sourcedefender dependency
InQuanto 3.4.0¶
07 March 2024
Significant improvements to circuit depth in
MultiConfigurationStateandMultiConfigurationAnsatzNew ansatz
MultiConfigurationStateBox, uses pytket’sStatePreparationBoxNew composite computable
ExpectationValueSumComputableNew helper methods in
inquanto.ansatzes:rotate_ansatz_restricted()andreference_circuit_builder()New examples for
MultiConfigurationStateBox,inquanto.operators.ChemistryRestrictedIntegralOperator.double_factorize(), and using CCSD amplitudes as VQE initial parameters.Note: examples are now split between inquanto examples and inquanto-extension examples
disp(display) option added forMinimizerSPSAMajor improvements to API documentation throughout
Bug fixes:
Fixed ‘=’ operator for
SymbolDictSeveral fixes in
AlgorithmSCEOM
symbol_substitution()with string maps now works for all ansatzes
InQuanto 3.3.1¶
31 January 2024
Bug fix relating to non-symbolic computables in PauliAveraging protocol runner
InQuanto 3.3.0¶
30 January 2024
Support for Python 3.12. Drop support for Python 3.9
New method
dataframe_partitioning()in PauliAveraging protocol for seeing relation between Pauli words and circuits.Driver for generating transverse-field Ising model hamiltonians (for example
DriverIsing1D)Introducing
ProtocolList. Basic support for collecting PauliAveraging protocols with different states.Bug fix relating to qubit indexing error in symmetry analysis of QubitOperators
Other bug fixes and development improvements
InQuanto-PySCF 1.5.0¶
30 January 2024
get_double_factorized_system()method added for PySCF driversPython 3.12 support and deprecate 3.9
InQuanto-NGLView v0.7.1¶
30 January 2024
Python 3.12 support and deprecate 3.9
Hotfix dependency update qcelemental
InQuanto-Phayes v0.2.0¶
30 January 2024
Python 3.12 support and deprecate 3.9
InQuanto 3.2.1¶
19 January 2024
Bug fix relating to symbol substitution in PauliAveraging protocol runner
InQuanto 3.2.0¶
12 January 2024
Three new computables added
OverlapMatrixComputablefor representing the general overlap matrix between two states \(S_{ij} = <\Psi_i|\hat{O}|\Psi_j>\)NonOrthogonalMatricesComputablefor representing matrices used by the non-orthogonal quantum eigensolver methodSCEOMMatrixComputablefor representing the Quantum Self Consistent Equation of Motion matrix
New protocol added
ProjectiveMeasurementsfor measuring the probabilities of the basis statesAdded the simultaneous perturbation stochastic approximation (SPSA) minimizer
MinimizerSPSAAdded
trotterize_as_linear_combination()to support second orderpd_safe_eigh()utility method now available to solve generalized eigenvalue problem \(HC = SCE\)Express files added for Purvis’ BeH2 potential energy surface (see the express manual page)
Added method to report point_group from a FermionSpace
point_group()Added Cholesky decomposition option to double factorization
Added
ensure_hermitian()to truncate non-hermitian matrix elementsMinor fix to DMET typing
Added launching and retrieving methods to QPE algorithms and protocols
Improved state hashing and comparison methods
Allow Pauli partitioning in HadamardTestOverlap to reduce measurement circuits (direct option)
Improved symbol substitution (parameter) errors and flexibility
Various other minor bug-fixes and improvements
InQuanto-PySCF 1.4.0¶
14 December 2023
Functions to get RDMs and PDMs from CASCI wavefunctions (e.g.
get_casci_12rdms())Bug fixes
InQuanto 3.1.2¶
28 November 2023
Hotfix for PMSV by adding stabilizer tolerances
Support for error mitigation when using protocol.build_from()
Clarified the qubit_operator.eigenspectrum method
InQuanto 3.1.1¶
15 November 2023
Hotfix: added unitary check options to the
DMETRHFembedding class
InQuanto 3.1.0¶
14 November 2023
Python 3.11 support
GraphColourMethod https://docs.quantinuum.com/tket/api-docs/partition.html#pytket._tket.partition.GraphColourMethod is now configurable in
PauliAveragingprotocolNew protocol
HadamardTestOverlapfor computing overlapsVarious big fixes and small improvements
Added compilation pass options to ansatz’s
to_CircuitAnsatzmethod
InQuanto 3.0.2¶
17 October 2023
Added support for pytket 1.21
Updated
GeometryMolecularto accept xyz stringsFixes for FCIDump reader
Added exact diagonalization helper method to QubitOperators
eigenspectrum()
InQuanto 3.0.1¶
10 October 2023
Improved license activation workflow
Improved API documentation
InQuanto 3.0.0¶
19 September 2023
Quantum phase estimation added
New algorithm class
AlgorithmDeterministicQPENew protocols for phase estimation:
Green’s functions added
Constructed and run through the use of new composite computables:
Added Qermit integration for quantum error mitigation: https://github.com/CQCL/Qermit
Additions to the
inquanto.expressmoduleget_system(): for quickly retrieving only the hamiltonian, fermion space, and fermion state from an express datafilesave_h5_system(): for saving a hamiltonian, fermion space, and fermion state to h5 fileget_noisy_backend(): for generating a simple, configurable, noisy quantum simulator
Overhaul of the
inquanto.computablesmoduleComputables no longer have responsibility for building or running circuits. They contain ingredients for computing an observable, and relations to other computables in an expression tree. Many have been renamed, and are now categorized into three submodules (* marks a new computable, and [old name if applicable]):
inquanto.computables.primitive(primitive objects for building computable expression trees):ComputableTuple[Computables]ComputableNDArray[ComputableArray]
inquanto.computables.atomic(these interact directly with inquanto protocols):MetricTensorReal[ComputableMetricTensorReal] (no longer multiplied by factor of 1/4)
inquanto.computables.composite(these are composed of atomic computables, and always have “Computable” appended to the end of the name):RestrictedOneBodyRDMComputable[ComputableRestrictedOneBodyRDM]UnrestrictedOneBodyRDMComputable[ComputableUnrestrictedOneBodyRDM]RestrictedOneBodyRDMRealComputable[ComputableRestrictedOneBodyRDMReal]UnrestrictedOneBodyRDMRealComputable[ComputableUnrestrictedOneBodyRDMReal]SpinlessNBodyRDMArrayRealComputable[ComputableSpinlessNBodyRDMTensorReal]SpinlessNBodyPDMArrayRealComputable[ComputableSpinlessNBodyPDMTensorReal]RDM1234RealComputable[ComputableRDM1234Real]PDM1234RealComputable[ComputablePDM1234Real]CommutatorComputable[ComputableCommutator]QSEMatricesComputable[ComputableQSEMatrices]
The following computables are no longer available:
ExpectationValueDerivativeRealOverlapSquaredKetDerivative
Overhaul of the
inquanto.protocolsmodule.Protocols now have complete responsibility for building and running observable measurement circuits. They’ve also been renamed and refactored to be simpler to use. Many are pickle-able for easy pause-resume of experiments.
New protocol names [old name]:
PauliAveraging[ProtocolDirect]HadamardTest[ProtocolIndirect]SwapTest[ProtocolCSP]DestructiveSwapTest[ProtocolDSP]ComputeUncompute[ProtocolVacuum]PhaseShift[ProtocolPhaseShift]HadamardTestDerivative[ProtocolHadamardDirectPauliY,ProtocolHadamardIndirectPauliY,ProtocolHadamardDirectPauliZ,ProtocolHadamardIndirectPauliZ]HadamardTestDerivativeOverlap[ProtocolHadamardDerivativeOverlap]SparseStatevectorProtocol[ProtocolStateVectorSparse]BackendStatevectorProtocol[ProtocolStateVectorBackendSupport]SymbolicProtocol[ProtocolSymbolic]
The following protocols are no longer available:
ProtocolMidMeasurementGradientProtocolVacuumPhaseShift
inquanto.protocols.supporterssubmodule is no longer available.Error mitigation is performed using Qermit or with new noise mitigation classes (available from the
inquanto.protocolsmodule):
Changes to the
inquanto.ansatzesmoduleRenaming of some ansatzes [old name]:
MultiConfigurationAnsatz[GivensAnsatz]MultiConfigurationState[MultiReferenceState]
RealBasisRotationAnsatzis replaced by three new classes, which have improved circuit depths:
QubitState/FermionStatehave been restructured to make their usage more consistent withQubitOperator/FermionOperatorMany bug fixes
InQuanto-PySCF 1.3.0¶
Upgraded to PySCF 2.3.0
Many more configurable options for drivers
More memory-efficient DMET calculations with inquanto-pyscf integral operators
Support for starting calculations from checkpoint files
CAS-AC0 calculations via
pyscf-ac0https://github.com/CQCL/pyscf-ac0WFT-in-DFT embedding, for molecular and periodic systems
Compatibility with InQuanto 3.0
2.1.1¶
27 April 2023
Some performance improvements
Fixed networkx dependence
Fixed numpy errors due to _typing
Other small fixes
A PDF version of InQuanto Version 2 documentation is also available: InQuanto-v211-PDF.
2.1.0¶
27 March 2023
Added double factorization
inquanto.operators.DoubleFactorizedHamiltonianAdded Real Basis Rotation Ansatz
inquanto.ansatzes.RealBasisRotationAnsatzAddition of some C++ components and functionality (speed up compact integrals)
Adding various tools for manipulating
inquanto.operators.QubitOperatorListQubitwise commutativity + improved tools for general commutativity
Added
inquanto.operators.OperatorList.sublist()and someinquanto.algorithms.adapt.AlgorithmFermionicAdaptVQEconvenience methods.Extra
inquanto.algorithms.time_evolution.AlgorithmVQSexamplesUpgrading Python support (up to 3.11) in line with pytket
Remove restriction on pytket-qiskit dependency requirement
inquanto.embeddings.dmetdocstringsImproved Impurity DMET exact diagonalization and VQE solver
Improved API documentation
inquanto-pyscf :
inquanto.extensions.pyscf.fmo.FMO, NEVPT2 methods e.g.get_nevpt2_correction(), and fixes.inquanto-nglview: improved API docs and fixes
2.0.0¶
5 December 2022
Re-designed ansatzes to provide more uniform interface, allow multireference calculations and easier custom ansatz development.
New ansatz classes added.
CircuitAnsatz,TrotterAnsatz,GivensAnsatz,MultiReferenceState,LayeredAnsatz..ProtocolStateVectorSparsenow caches results.New
ProtocolSymbolicclass allows for evaluation of expressions with symbolic ansatzes.Implementation of the QRDM-NEVPT2 method. Several new computables for RDM calculations.
Add support for real-time evolution in AlgorithmVQS.
New
CompactTwoBodyIntegralsS8for eight-fold symmetric compact integrals.Computable.cost_estimateandcost_estimate_elementwisefor circuit cost estimation on Quantinuum hardware.kupCCGSpDrefactored tokUpCCGSDSinglet.Pyscfrefactored toPySCF.
1.3.0¶
22 November 2022
Fix
FermionSpace.construct_number_alpha_operatorandFermionSpace.construct_number_beta_operator.Add
FermionOperator.to_latexandQubitOperator.to_latex.Add descriptions to files listed by
inquanto.express.list_h5.Fix bug where the PMSV supporter was sometimes not applied.
Add
QubitOperatorList.all_qubitsandQubitOperatorList.to_sparse_matrices.Allow
ChemistryRestrictedIntegralOperatorandFermionOperatorto be constructed from FCI files.Add
QubitState.from_ndarray.Remove
QubitSpace.generate_qubit_trotter_operator.Add exponentiation and Trotterization functionality to
QubitOperatorandQubitOperatorList.
1.2.2¶
22 September 2022
Fixed a typo in auxiliary expressions in ADAPT and VQS.
1.2.1¶
21 September 2022
Added import for QubitMappingParity at module level.
1.2.0¶
16 September 2022
Added optional compiler_passes argument to
Computable.run().Logger configured.
Workflow to synchronize branches develop and research-develop improved.
Compact 2-body integrals implemented.
ChemistryUnrestrictedIntegralOperator._freeze()implemented.Ansatzes deep copy implemented.
HVA fixed.
Convenience method to convert
FermionOperatorto integral operators implemented.Imaginary gradients sign fixed in protocols.
Various
FermionOperatorhelper methods implemented (is_hermitian,is_antihermitian,is_self_inverseetc.).Disable
QubitOperatorStringto be constructed with two Paulis on the same qubit.save_h5andload_h5implemented for spaces classes.Added
custom_prefixfor circuit names toComputable.run(),.launch()and.generate_circuits().Improvements to API documentation and type hints: Ansatzes, Algorithms, Mappings, Core, Geometries, Operators, Symmetry, Embeddings.
Fix exponent order issue in
FermionSpaceStateExpChemicallyAware.
1.1.0¶
29 July 2022
toeplitz_decompositionadded for QubitOperator.ProtocolSymbolicadded for symbolic evaluation of expectation values and computables.Fixed a bug in
Gradients(State vector protocols,ProtocolPhaseShift()andProtocolHadamardDirectPauliY())Fixed triplet excitations generator (can be used in QSE now)
General improvements in express module
MetricTensorcan now be used as part ofComputablesobjects
Padding methods added to
QubitOperatorImproved documentation
1.0.5¶
04 July 2022
Added ability for authentication by password.
Enabled support for any pytket v1.x release.
1.0.4¶
15 June 2022
Various minor bug fixes.
Improved validation output.
Updated sourcedefender dependency version.
1.0.3¶
10 June 2022
Added additional tests for parameter classes.
Fix for type safety in trigonometric methods.
Allowed api-key to be fetched from keyring or environment variable.
1.0.2¶
01 June 2022
Fixed bug in contracted systems symmetries.
Added finite difference metric tensor tests.
1.0.1¶
25 May 2022
Fixed bug in contracted systems symmetries.
Fixed bug in AlgorithmVQE property.
Fixed time-limit issue on decryption.