Simulating chemical systems may be used to reduce trial and error losses by predicting the properties of chemicals and expected outcomes of reactions. As quantum computers are based on quantum mechanics, quantum simulations may be used to natively simulate the behavior of electrons, atoms, and/or molecules in a system, more efficiently than can classical computing systems. Rather than consuming computational resources exponentially (e.g., 2n for an n electron system), quantum computers may only use polynomially many resources. This allows for the simulation of larger systems without relying on approximations that reduce the accuracy of resulting predictions.
This Summary is provided to introduce a selection of concepts in a simplified form that are further described below in the Detailed Description. This Summary is not intended to identify key features or essential features of the claimed subject matter, nor is it intended to be used to limit the scope of the claimed subject matter. Furthermore, the claimed subject matter is not limited to implementations that solve any or all disadvantages noted in any part of this disclosure.
In one disclosed example, a method for obtaining a solution to a multiproduct formula of order m to solve a quantum computing problem comprising a product formula. One example provides a method comprising selecting a set of exponents kj, wherein each kj is a real number and is an exponent in a linear combination of product formulas. Based on the set of exponents kj, a set of pre-factors aj is determined based on an underdetermined solution to an m×M system of linear equations, where M is a number of lower-order product formulas in the linear combination of product formulas. The set of exponents kj and the set of pre-factors aj are used to solve the quantum computing problem comprising the product formula. By minimizing the set of exponents kj and the set of pre-factors aj, sparse solutions to the multiproduct formula are generated, reducing computational time and scaling.
The curse of dimensionality underlies the difficulty of simulating quantum systems. As the Hilbert space dimension grows exponentially with particle number, classical computers require exponential time to accurately reproduce quantum dynamics. Fortunately, quantum computers show great promise in resolving this conundrum.
Many physical systems of interest, such as in superconductivity, chemistry, and general quantum field theories, are described by Hamiltonians H=Σj=1Nhj that are a sum of polynomially many N local terms. Even though each term modifies exponentially many amplitudes in the wavefunction, quantum computers may nevertheless apply time-evolution by each with a polynomial amount of physical resources.
A series of quantum gates may be generated that approximate the time-evolution of a Hamiltonian. Such time-evolution operators may be invoked as subroutines in additional quantum algorithms. For example, quantum algorithms may be used for factoring large numbers, which is important in many cryptography applications.
Just as there are many algorithms to multiply numbers or matrixes together, there are also many ways to design a quantum circuit that implements this time evolution operator. All of these different algorithms have various trade-offs, unique strengths and unique weaknesses. Some of them target special structures of the problems that are being simulated, others target different problems or structure types.
There is often a trade-off between the cost and complexity of implementing an algorithm. For example, to multiply two matrixes of dimension n×n, the traditional method has a complexity of n3. The best possible order for this operation has a complexity of n2.3. However, this algorithm is somewhat impractical because there exists a large constant factor that is applied to n. There exists much interest in designing quantum systems that operate more efficiently on a quantum computer. Improvements come both in terms of reducing exponents and in reducing the value of the constant factors. In most of these cases performance of the implementation can be quantified in terms of scaling with respect to time, number of terms, and target error of the simulation, as well as whether the exponents on these terms become smaller.
Early quantum simulation algorithms were based on an idea called Trotterization. To simulate a Hamiltonian that is the sum of many terms, the time-evolution for this Hamiltonian can be approximated by applying time-evolution to each term in sequence. Such quantum simulations may be efficiently performed on a quantum computer, e.g., in polynomial time and polynomial cost with respect to both the number of terms, and the target error.
However, Hamiltonians and other physical systems are described by more parameters than just time and number of terms. For example, given a system with two molecules that are far away from each other, it can be assumed that the two molecules do not interact with each other. As such, the cost of simulating these two pseudo-independent molecules should just be twice the cost of simulating one molecule. The cost of simulating n molecules should scale linearly with n. However, the most generic quantum simulation algorithms actually scale quadratically with respect to the number of terms n, because the structure of distance between terms is not introduced. For Hamiltonians, these algorithms assume the worst-case scenario, e.g., that every term can interact with every other term. Thus, simulation costs are based on the number of pair-wise interactions (n2). These types of structures in real systems are important and common but may not be exploited by the most generic quantum simulation algorithms.
Trotterization and subsequent variations (e.g., Trotter-Suzuki product formulas), take into account a very common type of structure and are of interest due to their simplicity and low space requirements. As an example, they may exploit how many terms in a Hamiltonian might commute with each other. This leads to far superior empirical performance on typical quantum systems than predicted by rigorous, but extremely loose upper bounds. The terms only interact with neighboring terms, rather than all terms, thus considering both strong and weak interactions based on inter-term distance. Thus, performing these simulations using a product formula simulation algorithm reduces the cost significantly compared with using the worst-case bounds.
At first order, time-evolution by the Hamiltonian is approximated by sequentially evolving by its parts, that is {right arrow over (U1)}(Δ)={right arrow over (Π)}j=1Ne−ih(Σj<k∥[hj, hk]∥Δ2). Thus evolution e−iHt for arbitrary long times t is accomplished by applying t/A approximate segments, each comprising of N exponentials, with A chosen to control the overall simulation error. Higher order variants achieve better scaling, and rigorous bounds place the number of exponentials required using an order m integrator at ≤2N5m(N maxj∥hj∥t)1+1/m/ϵ1/m. Due to its simplicity, this approach has been realized in experiments, and may even find useful applications in the near-term where decoherence still severely limits the number of quantum gates applied.
Ultimate limits on the performance of Hamiltonian simulation may be obtained by reducing worst-case computational problems to physical simulations. As these bounds indicate that the scaling should be strictly linear in time and logarithmic in error like
the polynomial gap between this and any product formula has ignited a flurry of post-Trotter simulation algorithms. These are based on different paradigms such as quantum walks, linear-combination-of-unitaries, qubitization, and quantum signal processing, and can match this lower bound with respect to all parameters.
In practice, product formula approaches are simulated for small systems, then extrapolated to larger systems. However, while such Trotter-Suzuki product formulas represent an improvement, they still have limitations, particularly at simulating worst-case problems.
Multi-product formulas were developed as an attempt to deal with many of the drawbacks of Trotter-Suzuki formulas for solving certain classes of differential equations. The principal idea behind them is to use a linear combination of Trotter formulas to construct a new integrator for a quantum system. However, most multi-product formulas are ill-conditioned, requiring precise cancellation of terms to generate plausible solutions.
For a quantum circuit that implements the time-evolution operator for a time (t), the number of quantum gates needed to apply for worst-case algorithms scales linearly in time. The scaling with respect to error is logarithmic, and the scaling with respect to the number of terms is quadratic. The simplest product formulas (e.g., first-order) have quadratic scaling in time, cubic scaling with respect to number of terms, and logarithmic scaling on error (e.g., 1/error). If the same product formula is used for a longer time, the errors sum, yielding a larger error that scales with simulation time. As the order of the product formula increases, the exponents on time and error also increase, with respect to the step size of the simulation. In other words, any order m product formula approximates real-time evolution for time t and error ϵ using a multiplicative factor more exponentials than post-Trotter simulation algorithms that achieve an optimal worst-case scaling
(t+log(1/ϵ), but lose the ability to exploit commutativity of terms.
Applying very high order Trotter-Suzuki product formulas for these worst-case problems can yield almost linear scaling in time, almost quadratic scaling in number of terms, and almost logarithmic scaling with respect to error. This nearly matches that generic worst-case algorithms and should have better performance for these structured Hamiltonians.
However, there also exist constant pre-factors that are applied to scaling and cost exponents. Generic quantum simulation algorithms have optimal scaling in these parameters, and also have a very small constant factor for worst-case problems. First order product formulas have relatively poor scaling, but the constant factors are small. However, for the higher order Trotter-Suzuki product formulas, the constant factor grows exponentially with the order of the product formula. There is thus a threshold for the product formula order, above which the absolute time needed to run a simulation becomes unfeasibly large. In practice, due to this enormous pre-factor, greater than 4th order product formulas are rarely used.
Though product formulas are asymptotically suboptimal for worst-case problems, their constant factors are significantly smaller than rigorous bounds suggest. Indeed, numerical studies demonstrate that simulation errors are much smaller than expected if some Hamiltonian terms commute, to the point of providing an asymptotic advantage. A most dramatic separation in performance is observed in simulating geometrically local interactions, where even naive applications of product formulas have an almost-linear (N1+o(1)) quantum gate cost in system size N. In contrast, post-Trotter simulation algorithms lose this desirable feature and, without highly specialized modifications, exhibit quadratic scaling Ω(N2).
Indeed, commutating terms are common in typical quantum systems, which motivates continued interest in product formulas. One approach is based on multiproduct formulas, where a higher order 2m integrator is constructed from a linear combination of M≥m lower-order product formulas:
wherein U represents the product formula, M is a number of lower-order product formulas comprised in the linear combination of product formulas, Δ is a step size, aj is a set of pre-factors, His a sum of Hamiltonians h, is a cost function, and N is a number of terms. For example, if a product formula is raised to the power of exponent k, the product formula would be applied k times sequentially. The cost of taking a linear combination of product formulas scales with the pre-factor aj. Error scales with the size of the Δ. In this example, there are M different product formulas, and thus M different step sized
In this example, there is a linear combination of these M different product formulas where each product formula is applied kj times according to that exponent's step size.
The linear combination of product formulas may be, for example the symmetric Trotter-Suzuki formula U2 (Δ)={right arrow over (U1)}(Δ/2)·1(Δ/2)=e−iHΔ+O(Δ4), abbreviating ∥h∥=maxj∥h∥j. With the simplest choice kj=j and M=m, only
(Nm2) exponentials are required, which appears to be exponential improvement over the
(N5m) required by Trotter-Suzuki formulas. Unfortunately, these multiproduct formulas are ill-conditioned—the coefficient (e.g., pre-factor) am=eΩ(m log m) grows exponentially with the order m. Thus, even the zeroth order constraint Σj=1maj=1 requires an extremely precise cancellation of terms. In the quantum setting, standard linear-combination-of-unitaries techniques translate this into an exponentially small success probability ∥{right arrow over (a)}∥1−2.
Herein, a quantum algorithm for Hamiltonian simulations is presented that maintains the average-case characteristics of product formulas, while reducing the gap in worst-case gate complexity from polynomial in t/ϵ to logarithmic. This is achieved by solving the conditioning problem faced by multiproduct formulas. By solving for the required cancellations using an underdetermined system, sparse solutions are generated. Such a technique may be bootstrapped to any product formula, including for classical simulations, thus preserving commutativity of Hamiltonian terms.
The more general under-determined setting in Eq. (1) is considered where M=m, but kj can be arbitrary rather than an arithmetic sequence. The technical result of this solution is that for integers kj of size maxj |kj|∈(m), well-conditioned solutions are generated to Eq. (1) where ∥{right arrow over (a)}∥1∈
(log m) is exponentially smaller. This may allow for the generation and application of higher order, yet low-cost product formulas. In effect, this reduces the number of computing operations needed to solve a quantum computing application, such as the time-evolution of a Hamiltonian. Combined with oblivious amplitude amplification, this allows an order m integrator to be implemented deterministically with
(poly(m)) cost. Thus, overhead is reduced to just
, which translates into a worst-case gate complexity of
(t log2+o(1)(t/ϵ)) for Hamiltonian simulations.
At 110, method 100 includes selecting a set of exponents kj, wherein each kj is a real number and is an exponent in a linear combination of product formulas. As an example, the linear combination of product formulas may be Eq (1).
wherein U represents the product formula, M is a number of lower-order product formulas comprised in the linear combination of product formulas, Δ is a step size, aj is a set of pre-factors, H is sum of Hamiltonians h, is a cost function, N is a number of terms. For example, if a product formula is raised to the power of exponent k, the product formula would be applied k times sequentially. The cost of taking a linear combination of product formulas scales with the pre-factor aj. Error scales with the size of the Δ. In this example, there are M different product formulas, and thus M different step sized
In this example, there is a linear combination of these M different product formulas where each product formula is applied kj times according to that exponent's step size.
The cost of implementing this linear combination of product formulas scales with the one-norm of the prefactors and the sum of the exponents. Method 100 may be used to generate a scheme for obtaining a very general class of multi-product formulas, where the pre-factors are all small (e.g., polynomial in size, rather than exponentially large). Such product formulas may be referred to as “well-conditioned product formulas”.
Theorem (Hamiltonian simulation by well-conditioned multiproduct formulas). There exists a quantum circuit based on multiproduct formulas U{right arrow over (k)} of the form in Eq. 1 that approximate the real-time evolution operator with error ϵ=∥U{right arrow over (k)}(t)−e−itΣ
exponentials, where λ=Σj=1N∥hj∥ and ∥{right arrow over (a)}∥1∥{right arrow over (k)}∥1Θ∈(m2 log
N
exp∈(Ntλ log2+o(1)(tλ/ϵ)). (3)
Explicit constructions are also provided where ∥â∥1∥{right arrow over (k)}∥1≈0.019 m2+0.11 log2 m).
Notably, this procedure may bootstrap off any product formula. Thus, it retains the product formula's desirable characteristics, and may similarly exhibit significantly better empirical performance than suggested by Theorem 1. For instance, Table 1 enumerates tighter bounds showing that
Multi-Product Formulas
Any symmetric product formula that approximates the time-evolution operator to at least leading order has the expansion
for some error matrices Ek and (Δ) that are independent of j. Note that
(Δ) in the Taylor series has a functional dependence on Δ due to contributions from e−iHΔ, which has no j dependence.
By taking a linear combination of these unitaries as described in Eq. (1), the cancellation of all lower order error terms may be engineered.
Returning to
Assuming that the kj are known a priori, the required cancellations may be cast as this system of linear equations. The left-hand side is a Vandermonde matrix, Vm,M({right arrow over (k)}−2)∈m×M, where {right arrow over (k)}−2=[k1{−2}, . . . , k{M}{−2}]. In the square case M=m, this has the solution
It may be observed that with the arithmetic progression kj=j, the coefficient am=eΩ(m log m) is indeed ill-conditioned.
However, a different choice of kj, that is not necessarily an arithmetic progression, may yield coefficients |aj| that are relatively small. In that case, U{right arrow over (k)}(Δ) may be efficiently applied using standard quantum techniques. To illustrate, one may consider a quantum state preparation circuit B|0=|a
=Σj=1m|aj|/∥aj∥1|j
and a multiplexer
These apply the multiproduct formula (a|a⊗I)S(
a|a⊗I)=U{right arrow over (k)}(Δ)/∥{right arrow over (a)}∥1 with success probability 1/∥{right arrow over (a)}∥12. Fortunately, that may be amplified using robust oblivious amplitude amplification to 1−
(ϵ), so long as U{right arrow over (k)}(Δ) is ϵ-close to being unitary. Each U{right arrow over (k)}(Δ) may be cost in terms of queries made to the underlying product formula U2·S queries U2 ∥{right arrow over (k)}∥1 times, which then multiplied by ∥{right arrow over (a)}∥1 for the amplification routine. Clearly, performance is improved with small ∥{right arrow over (a)}∥1 values.
Returning to
Values for kj are real numbers, and typically integers. Previously, values for kj were selected as arithmetic progressions. Given a progression of kj, values for aj may be determined using Eq. (5). However, this choice of values leads to coefficients that increase exponentially. Using method 100, any progression of kj may be selected, and Eq. (5) may be used to derive small coefficients for any given progression.
Well-Conditioned Fractional-Query Multiproduct Formulas
The above-described solution relaxes the conditions of Eq. (1) by allowing the exponents {right arrow over (k)} to be arbitrary real numbers. This corresponds to fractional queries to U2, which may be implemented using standard techniques. In this setting, Eq. (5) may be mapped to a polynomial interpolation problem.
For example, consider a set of m polynomials {pj(x)=Σi=1mAj,ixi-1}j=1m with coefficients represented as the square matrix A∈m×m. These may be chosen to be orthogonal over some discrete set of interpolation points {right arrow over (x)}, that is {right arrow over (pj)}=[pj(x1), pj(x2), . . . , pj(xm)] and
{right arrow over (p)}
j
,{right arrow over (p)}
k
=Σi=1mpj(xi)pk(xi)∝δjk, (7)
where δjk is the Kronecker delta function.
Now, the Vandermonde matrix may be left-multiplied by the polynomial coefficients A. Thus, the jth row satisfies
(A·Vm,m({right arrow over (x)})·{right arrow over (a)})j={right arrow over (pj)},{right arrow over (a)}
=(A·
)j=Aj,1 (8)
Using the orthogonality relationship in Eq. (7), this may be solved by the ansatz
The Chebyshev polynomial basis Tj(x)=cos(j cos−1(x)) thus may furnish a set of multiproduct coefficients with desirable properties.
Lemma 1: Chebyshev Fractional Multiproduct
Choose Vm,m({right arrow over (x)}) in Eq. (5) with
Then {right arrow over (a)} and {right arrow over (k)} satisfy
∥{right arrow over (a)}∥1∈Θ(log m), and ∥{right arrow over (k)}∥1∈Θ(m log m).
Proof. Choose a basis set of shifted Chebyshev polynomials pj(x)≡Tj-1(2x−1) and interpolate and
For example, the Chebyshev polynomials facts
and pj(0)=−(−1)j may be used.
Thus the function
implies aj=
where the fact kj=1/√{square root over (xj)} and the inequality ∀x∈[0, π/2],
have been used.
This solution is remarkably robust to perturbations. For instance, dropping the latter half of xj does not affect its qualitative properties, as seen in the following result.
Lemma 2: Half-Chebyshev Fractional Multiproduct
Choose Vm,m({right arrow over (x)}) in Eq. (5) with
Then {right arrow over (a)} and {right arrow over (k)} scale as in Lemma 1.
Proof. Bootstrap off the solution in Lemma 1 with 2m interpolation points
which has multiproduct coefficients {ãj}j=12m given by Eq. (9). Using the exact solution Eq. (6), it may be observed that
which follows from 0<{tilde over (x)}j< for all 1≤j<q≤2m. Similarly to Lemma 1, the quantities
and
may be evaluated.
Well-Conditioned Integer-Query Multiproduct Formulas
Lemmas 1 and 2 choose kj to be real numbers but not necessarily integers. This shows, generally, that with real numbers Eq. (5) can be solved to get very small coefficients. Since both sums of exponents and coefficients are small, their product is small, and so higher order product formulas can be used at reduced cost. However, solutions that use real numbers for kj may be impractical to implement. Still, this provides proof-of the-principle that, if you can use real numbers for kj, cost can be reduced.
It may now be shown that the fractional query solutions may be converted into integer query solutions by rescaling with a suitable constant K and rounding each exponent kj=K/√{square root over (xj)}, to a different integer lj—otherwise V({right arrow over (l)}−2) becomes singular. This bootstrapping doesn't raise the cost significantly and may still yield polynomial scaling of the coefficients with respect to the order.
Rounding also perturbs the multiproduct coefficients d, but similar to the robustness of Lemma 2, ∥{right arrow over (a)}∥1 changes by at most a multiplicative constant, as shown below.
Lemma 3: Half-Chebyshev Integer Multiproduct
Choose Vm,m({right arrow over (l)}−2) in Eq. (5), where lj=┌kj┐, kj=K/√{square root over (xj)}, xj are from Lemma 2, and K∈Θ(m). Then ∥{right arrow over (a)}∥1∈Θ(log m), and ∥{right arrow over (l)}∥1∈Θ(m2 log m).
Proof From the definition of xj, note that kj∈Θ(Km/j), and K∈Θ(m) in order for lj and kj to round to unique integers. Thus the perturbation ∥lj−kj|=δj∈Θ(K/m) and the fractional change in γq=(kq/kj)2 is
where the sign of Δ[q, j] matches the sign of (q−j).
The change between
and the original
may now be evaluated. As Δ[q, j] is small, the shift in ãj to leading order may be evaluated by using the derivatives
where in the last line, asymptotic expressions are substituted for xj, xq.
As the exponents kj have been chosen a priori, a smaller one-norm ∥{right arrow over (a)}∥1 might be possible if ∥{right arrow over (a)}∥1 is minimized over to all
subsets {kj}j=1m⊆[M]. Surprisingly, exact solutions to this discrete optimization problem can be obtained efficiently through the linear program
followed by minimizing with respect to m∈[M]. Importantly, minimizing the one-norm also ensures that the solution d has exactly m non-zero elements, analogous to sparse signal recovery in compressed sensing. In this context, “minimizing” refers to a procedure for reducing the relative values and/or sums of components, and not necessarily to deriving a global minimum value.
Eq. (5) has traditionally be chosen to be a square matrix, meaning that the number of free parameters (k) is exactly equal to the order of the integrator. Herein, Eq. (5) is being solved as an underdetermined system, meaning that there are excess free parameters. In other words, there can be more values for kj than the order M of the integrator. By solving this underdetermined system, using the phrasing of the optimization problem in Eq. (13), solutions can be derived that are sparse. As one example, sparse solutions include as many aj values as possible will be =0. Additionally or alternatively, a subset of aj values are set to zero and/or small values. As such, even though there is an arithmetic progression in Vandermonde matrix in Eq. (5), in some examples all of the coefficients that can be zero are set to zero, assuming that the one-norm of these coefficients is as small as possible. By making the solution sparse, the cost of the algorithm also depends on one-norm of kj, but if the coefficient of aj is 0, the corresponding kj is not applied, and the one-norm of k is only a sum of the kj values that are associated with a positive aj value.
Worst-Case Error Bounds
Rigorous, but loose, bounds may now be provided on the error of multiproduct integrators, thus completing the proof of Theorem 1.
Proof of Theorem 1. Denote the remainder of any function by m[Σj=0∞cjxj]=Σj=m+1∞cjxj. Observe the remainder of the product formula
has an error bound independent of the exponent j, where λ=Σj=1N∥hj∥, and the inequalities
and ∥m[ΠjeΔh
m[eΣ
Thus, a single multiproduct segment has error
By applying r≤1/ϵt/r segments and using the inequality (1+ϵt/r)r≤erϵ
Choose, for example,
Now define z=W(log(tλ/ϵ)) using the Lambert-W function which solves log(tλ/ϵ)=(z)ez, and choose 2m+1=ez. The number of exponentials required in total to implement U{right arrow over (k)}r(t/r) is then
where ∥{right arrow over (a)}∥1∥{right arrow over (k)}∥1 scale according to Lemma 3.
These theoretical solutions scale similarly to the minimized solutions (e.g. the solutions that are the result of the minimization process, which may or may not be actual minima), which are presented in Table 1. Table 1 presents multi-product solutions to Eq. (1) that minimize ∥{right arrow over (a)}∥1∥{right arrow over (k)}∥1, where {right arrow over (k)} only contains the kj exponents that correspond to non-zero aj coefficients. Both theoretical and practical solutions allow for the generation and application of higher order, yet low-cost product formulas as applied to solving quantum computing application, such as the time-evolution of a Hamiltonian. The technical effects of implementing these solutions include a reduction in the number of computing operations needed to generate a solution, reducing the time and computing power necessary to perform quantum simulations.
Although primarily described with regard to symmetric product formulas, such as the second order symmetric Trotter-Suzuki product formula, similar methods may be applied to other product formula types. For example, variations on the expansion shown in Eq. (4) may yield variations on the Vandermonde matrix shown in Eq (5). Solutions to these variations may be used to generate valid multiproduct formulas.
For example, when the underlying product formula is symmetric and of order α, rather than order 2, a slightly different system of equations may be solved:
When the underlying product formula is non-symmetric and of order 1, the following system of equations may be solved:
When the underlying product formula is non-symmetric and of order α, the following system of equations may be solved:
As described for Eq. (5), underdetermined solutions to Eqs. (17-19) may be generated such that kj is not necessarily an arithmetic progression, (e.g., using Eq. (13)). By being more flexible in choosing the exponents kj, well-conditioned multiproduct formulas may be generated with desirable properties, wherein the sum of absolute values of the coefficients is relatively small.
In some embodiments, the methods and processes described herein may be tied to a quantum computing system of one or more quantum computing devices.
The qubits of register 312 may take various forms, depending on the desired architecture of quantum computer 310. Each qubit 314 may comprise: a superconducting Josephson junction, a trapped ion, a trapped atom coupled to a high-finesse cavity, an atom or molecule confined within a fullerene, an ion or neutral dopant atom confined within a host lattice, a quantum dot exhibiting discrete spatial- or spin-electronic states, electron holes in semiconductor junctions entrained via an electrostatic trap, a coupled quantum-wire pair, an atomic nucleus addressable by magnetic resonance, a free electron in helium, a molecular magnet, or a metal-like carbon nanosphere, as nonlimiting examples. More generally, each qubit 314 may comprise any particle or system of particles that can exist in two or more discrete quantum states that can be measured and manipulated experimentally. For instance, a qubit may also be implemented in the plural processing states corresponding to different modes of light propagation through linear optical elements (e.g., mirrors, beam splitters and phase shifters), as well as in states accumulated within a Bose-Einstein condensate.
Returning now to
Controller 318 of quantum computer 310 is configured to receive a plurality of inputs 326 and to provide a plurality of outputs 328. The inputs and outputs may each comprise digital and/or analog lines. At least some of the inputs and outputs may be data lines through which data is provided to and extracted from the quantum computer. Other inputs may comprise control lines via which the operation of the quantum computer may be adjusted or otherwise controlled.
Controller 318 is operatively coupled to register 312 via interface 330. The interface is configured to exchange data billirectionally with the controller. The interface is further configured to exchange signal corresponding to the data billirectionally with the register. Depending on the architecture of quantum computer 310, such signal may include electrical, magnetic, and/or optical signal. Via signal conveyed through the interface, the controller may interrogate and otherwise influence the quantum state held in the register, as defined by the collective quantum state of the array of qubits 314. To this end, the interface includes at least one modulator 332 and at least one demodulator 334, each coupled operatively to one or more qubits of register 312. Each modulator is configured to output a signal to the register based on modulation data received from the controller. Each demodulator is configured to sense a signal from the register and to output data to the controller based on the signal. The data received from the demodulator may, in some scenarios, be an estimate of an observable to the measurement of the quantum state held in the register.
More specifically, suitably configured signal from modulator 332 may interact physically with one or more qubits 314 of register 312 to trigger measurement of the quantum state held in one or more qubits. Demodulator 334 may then sense a resulting signal released by the one or more qubits pursuant to the measurement, and may furnish the data corresponding to the resulting signal to the controller. Stated another way, the demodulator may be configured to reveal, based on the signal received, an estimate of an observables reflecting the quantum state of one or more qubits of the register, and to furnish the estimate to controller 318. In one non-limiting example, the modulator may provide, based on data from the controller, an appropriate voltage pulse or pulse train to an electrode of one or more qubits, to initiate a measurement. In short order, the demodulator may sense photon emission from the one or more qubits and may assert a corresponding digital voltage level on an interface line into the controller. Generally speaking, any measurement of a quantum-mechanical state is defined by the operator Ô corresponding to the observable to be measured; the result R of the measurement is guaranteed to be one of the allowed eigenvalues of Ô. In quantum computer 310, R is statistically related to the register state prior to the measurement, but is not uniquely determined by the register state.
Pursuant to appropriate input from controller 318, interface 330 may be further configured to implement one or more quantum-logic gates to operate on the quantum state held in register 312. Whereas the function of each type of logic gate of a conventional computer system is described according to a corresponding truth table, the function of each type of quantum gate is described by a corresponding operator matrix. The operator matrix operates on (i.e., multiplies) the complex vector representing the register state and effects a specified rotation of that vector in Hilbert space.
Continuing in
In some examples, plural signal levels may be applied for plural sequences or otherwise associated durations. In a more particular example, the plural signal levels and durations are arranged to form a composite signal waveform, which may be applied to one or more qubits of the register. In general, each signal level Si and each duration Ti is a control parameter adjustable by appropriate programming of controller 318. In other quantum-computing architectures, different sets of adjustable control parameters may control the quantum operation applied to the register state.
In some embodiments, the methods and processes described herein may be tied to a classical computing system of one or more classical computing devices. In particular, such methods and processes may be implemented as a computer-application program or service, an application-programming interface (API), a library, and/or other computer-program product.
Computing system 500 includes a logic machine 510 and a storage machine 520. Computing system 500 may optionally include a display subsystem 530, input subsystem 540, communication subsystem 550, and/or other components not shown in
Logic machine 510 includes one or more physical devices configured to execute instructions. For example, the logic machine may be configured to execute instructions that are part of one or more applications, services, programs, routines, libraries, objects, components, data structures, or other logical constructs. Such instructions may be implemented to perform a task, implement a data type, transform the state of one or more components, achieve a technical effect, or otherwise arrive at a desired result.
The logic machine may include one or more processors configured to execute software instructions. Additionally or alternatively, the logic machine may include one or more hardware or firmware logic machines configured to execute hardware or firmware instructions. Processors of the logic machine may be single-core or multi-core, and the instructions executed thereon may be configured for sequential, parallel, and/or distributed processing. Individual components of the logic machine optionally may be distributed among two or more separate devices, which may be remotely located and/or configured for coordinated processing. Aspects of the logic machine may be virtualized and executed by remotely accessible, networked computing devices configured in a cloud-computing configuration.
Storage machine 520 includes one or more physical devices configured to hold instructions executable by the logic machine to implement the methods and processes described herein. When such methods and processes are implemented, the state of storage machine 520 may be transformed—e.g., to hold different data.
Storage machine 520 may include removable and/or built-in devices. Storage machine 520 may include optical memory (e.g., CD, DVD, HD-DVD, Blu-Ray Disc, etc.), semiconductor memory (e.g., RAM, EPROM, EEPROM, etc.), and/or magnetic memory (e.g., hard-disk drive, floppy-disk drive, tape drive, MRAM, etc.), among others. Storage machine 520 may include volatile, nonvolatile, dynamic, static, read/write, read-only, random-access, sequential-access, location-addressable, file-addressable, and/or content-addressable devices.
It will be appreciated that storage machine 520 includes one or more physical devices. However, aspects of the instructions described herein alternatively may be propagated by a communication medium (e.g., an electromagnetic signal, an optical signal, etc.) that is not held by a physical device for a finite duration.
Aspects of logic machine 510 and storage machine 520 may be integrated together into one or more hardware-logic components. Such hardware-logic components may include field-programmable gate arrays (FPGAs), program- and application-specific integrated circuits (PASIC/ASICs), program- and application-specific standard products (PSSP/ASSPs), system-on-a-chip (SOC), and complex programmable logic devices (CPLDs), for example.
When included, display subsystem 530 may be used to present a visual representation of data held by storage machine 520. This visual representation may take the form of a graphical user interface (GUI). As the herein described methods and processes change the data held by the storage machine, and thus transform the state of the storage machine, the state of display subsystem 530 may likewise be transformed to visually represent changes in the underlying data. Display subsystem 530 may include one or more display devices utilizing virtually any type of technology. Such display devices may be combined with logic machine 510 and/or storage machine 520 in a shared enclosure, or such display devices may be peripheral display devices.
When included, input subsystem 540 may comprise or interface with one or more user-input devices such as a keyboard, mouse, touch screen, or game controller. In some embodiments, the input subsystem may comprise or interface with selected natural user input (NUI) componentry. Such componentry may be integrated or peripheral, and the transduction and/or processing of input actions may be handled on- or off-board. Example NUI componentry may include a microphone for speech and/or voice recognition; an infrared, color, stereoscopic, and/or depth camera for machine vision and/or gesture recognition; a head tracker, eye tracker, accelerometer, and/or gyroscope for motion detection and/or intent recognition; as well as electric-field sensing componentry for assessing brain activity.
When included, communication subsystem 550 may be configured to communicatively couple computing system 500 with one or more other computing devices. Communication subsystem 550 may include wired and/or wireless communication devices compatible with one or more different communication protocols. As non-limiting examples, the communication subsystem may be configured for communication via a wireless telephone network, or a wired or wireless local- or wide-area network. In some embodiments, the communication subsystem may allow computing system 500 to send and/or receive messages to and/or from other devices via a network such as the Internet.
In one example, enacted via execution of stored instructions on a computing device, a method for obtaining a solution to a multiproduct formula of order m to solve a quantum computing problem comprising a product formula comprises: selecting a set of exponents kj, wherein each kj is a real number and is an exponent in a linear combination of product formulas; based on the set of exponents kj, determining the set of pre-factors based on an underdetermined solution to an m×M system of linear equations in which the exponents are expressed as a Vandermonde matrix Vm,M(k−α)∈m×M where α is an order of the product formula, and where M is a number of lower-order product formulas comprised in the linear combination of product formulas; and using the set of exponents kj and the set of pre-factors aj to solve the quantum computing problem comprising the product formula. In such an example, or any other example, the m×M system of linear equations is additionally or alternatively expressed as:
wherein the quantum computing problem is additionally or alternatively a Hamiltonian simulation, and wherein the linear combination of product formulas is additionally or alternatively as follows:
wherein U represents the product formula, Δ is a step size, is a set of pre-factors, H is a sum of Hamiltonians h, is a cost function, and N is a number of terms. In any of the preceding examples, or any other example, the linear combination of product formulas is additionally or alternatively an expression of the symmetric Trotter-Suzuki formula as follows: U2(Δ)={{right arrow over (U)}1(Δ/2)·{
(Δ/2)=e−iHΔ+
(Δ4). In any of the preceding examples, or any other example wherein α=2, the Vandermonde matrix is additionally or alternatively as follows:
In any of the preceding examples, or any other example wherein M=m, the underdetermined solution to the m×M system of linear equations additionally or alternatively has the solution:
In any of the preceding examples, or any other example, the underdetermined solution to the m×M system of linear equations is additionally or alternatively determined based on the following linear program:
In any of the preceding examples, or any other example, the underdetermined solution to the m×M system of linear equations is additionally or alternatively based on fractional queries to U2, and wherein the exponents are arbitrary real numbers. In any of the preceding examples, or any other example, the underdetermined solution to the m×M system of linear equations is additionally or alternatively determined based on a fractional multiproduct wherein Vm,m({right arrow over (x)}) is chosen such that
In another example, a computing device, comprises a processor; and a storage device holding instructions that, in response to a request to obtain a solution to a multiproduct formula of order m to solve a quantum computing problem comprising a product formula, cause the processor to: select a set of exponents kj, wherein each kj is a real number and is an exponent in the following linear combination of product formulas:
wherein U represents the product formula, M is a number of lower-order product formulas comprised in the linear combination of product formulas, Δ is a step size, aj is a set of pre-factors, H is sum of Hamiltonians h, is a cost function, N is a number of terms; based on the set of exponents kj, determine the set of pre-factors based on an underdetermined solution to the following m×M system of linear equations
and use the set of exponents kj and the set of pre-factors aj to solve the quantum computing problem comprising the product formula. In such an example, or any other example, the linear combination of product formulas is additionally or alternatively the symmetric Trotter-Suzuki formula: U2(Δ)={{right arrow over (U1)}(Δ/2)·{(Δ/2)=e−iHΔ+O(Δ4). In any of the preceding examples, or any other example wherein M=m, the underdetermined solution to the m×M system of linear equations additionally or alternatively has the solution:
In any of the preceding examples, or any other example, the underdetermined solution to the m×M system of linear equations is additionally or alternatively determined based on the following linear program:
In any of the preceding examples, or any other example, the underdetermined solution to the m×M system of linear equations is additionally or alternatively based on fractional queries to U2, and the exponents are additionally or alternatively arbitrary real numbers. In any of the preceding examples, or any other example, the underdetermined solution to the m×M system of linear equations is additionally or alternatively determined based on a fractional multiproduct wherein Vm,m({right arrow over (x)}) is additionally or alternatively chosen such that
In any of the preceding examples, or any other example, the computing device is additionally or alternatively a quantum computing device further comprising: a register including a plurality of qubits; a modulator configured to implement a quantum-logic operation on the plurality of qubits according to control-parameter values stored at the storage device; and a demodulator configured to reveal data reflecting a quantum state of the plurality of qubits; and wherein the controller is operatively coupled to the modulator and to the demodulator. In any of the preceding examples, or any other example, the computing device is additionally or alternatively a classical computing device.
In yet another example, a quantum-computing device implemented method for simulating time-evolution of a Hamiltonian via a multiproduct formula of order m, comprises: selecting a set of exponents kj, wherein each kj is a real number and is an exponent in the following linear combination of product formulas:
wherein U represents the product formula, M is a number of lower-order product formulas comprised in the linear combination of product formulas, Δ is a step size, aj is a set of pre-factors, H is sum of Hamiltonians h, is a cost function, N is a number of terms; based on the set of exponents kj, determining the set of pre-factors aj based on an underdetermined solution to the following m×M system of linear equations:
wherein the underdetermined solution is based on the following linear program
and using the set of exponents kj and the set of pre-factors aj to simulating time-evolution of the Hamiltonian. In such an example, or any other example wherein M=m, the underdetermined solution to the m×M system of linear equations additionally or alternatively has the solution:
In any of the preceding examples, or any other example, the underdetermined solution to the m×M system of linear equations is additionally or alternatively based on fractional queries to U2, and wherein the exponents kj are additionally or alternatively arbitrary real numbers. In any of the preceding examples, or any other example, the linear combination of product formulas is additionally or alternatively the symmetric Trotter-Suzuki formula: U2(Δ)={{right arrow over (U)}1(Δ/2)·{(Δ/2)=E−iHΔ+O(Δ4).
It will be understood that the configurations and/or approaches described herein are exemplary in nature, and that these specific embodiments or examples are not to be considered in a limiting sense, because numerous variations are possible. The specific routines or methods described herein may represent one or more of any number of processing strategies. As such, various acts illustrated and/or described may be performed in the sequence illustrated and/or described, in other sequences, in parallel, or omitted. Likewise, the order of the above-described processes may be changed.
The subject matter of the present disclosure includes all novel and non-obvious combinations and sub-combinations of the various processes, systems and configurations, and other features, functions, acts, and/or properties disclosed herein, as well as any and all equivalents thereof.