57 qbdt->GetQuantumState(sv.get());
59 engine->GetQuantumState(sv.get());
61 nEngine->SetQuantumState(sv.get());
63 qbdt = std::dynamic_pointer_cast<QBdt>(nEngine);
67 engine = std::dynamic_pointer_cast<QEngine>(nEngine);
81 (
bitLenInt)(getenv(
"QRACK_PSTRIDEPOW") ? std::stoi(std::string(getenv(
"QRACK_PSTRIDEPOW"))) : PSTRIDEPOW);
94 const double threshold = getenv(
"QRACK_QBDT_HYBRID_THRESHOLD")
95 ? std::stod(getenv(
"QRACK_QBDT_HYBRID_THRESHOLD"))
107 const size_t count =
qbdt->CountBranches();
116 bool randomGlobalPhase =
true,
bool useHostMem =
false, int64_t deviceId = -1,
bool useHardwareRNG =
true,
117 bool useSparseStateVec =
false,
real1_f norm_thresh =
REAL1_EPSILON, std::vector<int64_t> devList = {},
123 bool useHostMem =
false, int64_t deviceId = -1,
bool useHardwareRNG =
true,
bool useSparseStateVec =
false,
129 bool useHostMem =
false, int64_t deviceId = -1,
bool useHardwareRNG =
true,
bool useSparseStateVec =
false,
133 useHostMem, deviceId, useHardwareRNG, useSparseStateVec, norm_thresh, devList, qubitThreshold,
154 return qbdt->ProbReg(start, length, permutation);
156 return engine->ProbReg(start, length, permutation);
163 toCopy->SwitchMode(!
engine);
165 return engine->Compose(toCopy->engine);
177 toCopy->SwitchMode(!
engine);
179 return engine->Compose(toCopy->engine, start);
189 return Compose(std::dynamic_pointer_cast<QBdtHybrid>(toCopy), start);
194 toCopy->SwitchMode(!
engine);
196 return engine->ComposeNoClone(toCopy->engine);
206 return ComposeNoClone(std::dynamic_pointer_cast<QBdtHybrid>(toCopy));
215 q = std::dynamic_pointer_cast<QBdt>(
qbdt->Decompose(start, length));
218 e = std::dynamic_pointer_cast<QEngine>(
engine->Decompose(start, length));
227 Decompose(start, std::dynamic_pointer_cast<QBdtHybrid>(dest));
231 return TryDecompose(start, std::dynamic_pointer_cast<QBdtHybrid>(dest), error_tol);
236 dest->SwitchMode(
false);
237 if (
engine->TryDecompose(start, dest->engine, error_tol)) {
246 dest->SwitchMode(!
engine);
248 qbdt->Decompose(start, dest->qbdt);
251 engine->Decompose(start, dest->engine);
258 qbdt->Dispose(start, length);
261 engine->Dispose(start, length);
268 qbdt->Dispose(start, length, disposedPerm);
271 engine->Dispose(start, length, disposedPerm);
283 qbdt->Allocate(start, length);
285 engine->Allocate(start, length);
295 qbdt->SetQuantumState(inputState);
297 engine->SetQuantumState(inputState);
303 qbdt->GetQuantumState(outputState);
305 engine->GetQuantumState(outputState);
311 qbdt->GetProbs(outputProbs);
313 engine->GetProbs(outputProbs);
319 return qbdt->GetAmplitude(perm);
321 return engine->GetAmplitude(perm);
326 qbdt->SetAmplitude(perm, amp);
328 engine->SetAmplitude(perm, amp);
334 qbdt->SetPermutation(perm, phaseFac);
344 qbdt->Mtrx(mtrx, qubitIndex);
346 engine->Mtrx(mtrx, qubitIndex);
352 qbdt->Phase(topLeft, bottomRight, qubitIndex);
354 engine->Phase(topLeft, bottomRight, qubitIndex);
360 qbdt->Invert(topRight, bottomLeft, qubitIndex);
362 engine->Invert(topRight, bottomLeft, qubitIndex);
368 qbdt->MCMtrx(controls, mtrx, target);
371 engine->MCMtrx(controls, mtrx, target);
377 qbdt->MACMtrx(controls, mtrx, target);
380 engine->MACMtrx(controls, mtrx, target);
386 const complex* mtrxs,
const std::vector<bitCapInt> mtrxSkipPowers,
const bitCapInt& mtrxSkipValueMask)
389 qbdt->UniformlyControlledSingleBit(controls, qubitIndex, mtrxs, mtrxSkipPowers, mtrxSkipValueMask);
392 engine->UniformlyControlledSingleBit(controls, qubitIndex, mtrxs, mtrxSkipPowers, mtrxSkipValueMask);
407 qbdt->PhaseParity(radians, mask);
409 engine->PhaseParity(radians, mask);
416 return qbdt->CProb(control, target);
418 return engine->CProb(control, target);
423 return qbdt->ACProb(control, target);
425 return engine->ACProb(control, target);
431 qbdt->UniformParityRZ(mask, angle);
434 engine->UniformParityRZ(mask, angle);
440 qbdt->CUniformParityRZ(controls, mask, angle);
443 engine->CUniformParityRZ(controls, mask, angle);
450 qbdt->CSwap(controls, qubit1, qubit2);
453 engine->CSwap(controls, qubit1, qubit2);
459 qbdt->AntiCSwap(controls, qubit1, qubit2);
462 engine->AntiCSwap(controls, qubit1, qubit2);
468 qbdt->CSqrtSwap(controls, qubit1, qubit2);
471 engine->CSqrtSwap(controls, qubit1, qubit2);
477 qbdt->AntiCSqrtSwap(controls, qubit1, qubit2);
480 engine->AntiCSqrtSwap(controls, qubit1, qubit2);
486 qbdt->CISqrtSwap(controls, qubit1, qubit2);
489 engine->CISqrtSwap(controls, qubit1, qubit2);
495 qbdt->AntiCISqrtSwap(controls, qubit1, qubit2);
498 engine->AntiCISqrtSwap(controls, qubit1, qubit2);
505 return qbdt->ForceM(qubit, result, doForce, doApply);
507 return engine->ForceM(qubit, result, doForce, doApply);
544 qbdt->INC(toAdd, start, length);
546 engine->INC(toAdd, start, length);
552 qbdt->DEC(toSub, start, length);
554 engine->DEC(toSub, start, length);
560 qbdt->CDEC(toSub, inOutStart, length, controls);
563 engine->CDEC(toSub, inOutStart, length, controls);
569 qbdt->INCDECC(toAdd, start, length, carryIndex);
571 engine->INCDECC(toAdd, start, length, carryIndex);
577 qbdt->CINC(toAdd, inOutStart, length, controls);
580 engine->CINC(toAdd, inOutStart, length, controls);
586 qbdt->INCC(toAdd, start, length, carryIndex);
589 engine->INCC(toAdd, start, length, carryIndex);
595 qbdt->INCS(toAdd, start, length, overflowIndex);
598 engine->INCS(toAdd, start, length, overflowIndex);
604 qbdt->DECS(toAdd, start, length, overflowIndex);
607 engine->DECS(toAdd, start, length, overflowIndex);
613 engine->INCSC(toAdd, start, length, overflowIndex, carryIndex);
618 engine->INCSC(toAdd, start, length, carryIndex);
623 qbdt->DECC(toSub, start, length, carryIndex);
626 engine->DECC(toSub, start, length, carryIndex);
632 engine->DECSC(toSub, start, length, overflowIndex, carryIndex);
637 engine->DECSC(toSub, start, length, carryIndex);
643 engine->INCDECSC(toAdd, start, length, overflowIndex, carryIndex);
648 engine->INCDECSC(toAdd, start, length, carryIndex);
654 engine->INCBCD(toAdd, start, length);
659 engine->INCBCDC(toAdd, start, length, carryIndex);
664 engine->DECBCDC(toSub, start, length, carryIndex);
670 qbdt->MUL(toMul, inOutStart, carryStart, length);
672 engine->MUL(toMul, inOutStart, carryStart, length);
678 qbdt->DIV(toDiv, inOutStart, carryStart, length);
680 engine->DIV(toDiv, inOutStart, carryStart, length);
687 qbdt->MULModNOut(toMul, modN, inStart, outStart, length);
689 engine->MULModNOut(toMul, modN, inStart, outStart, length);
696 qbdt->IMULModNOut(toMul, modN, inStart, outStart, length);
698 engine->IMULModNOut(toMul, modN, inStart, outStart, length);
705 engine->POWModNOut(base, modN, inStart, outStart, length);
708 const std::vector<bitLenInt>& controls)
711 qbdt->CMUL(toMul, inOutStart, carryStart, length, controls);
714 engine->CMUL(toMul, inOutStart, carryStart, length, controls);
718 const std::vector<bitLenInt>& controls)
721 qbdt->CDIV(toDiv, inOutStart, carryStart, length, controls);
724 engine->CDIV(toDiv, inOutStart, carryStart, length, controls);
728 bitLenInt length,
const std::vector<bitLenInt>& controls)
731 qbdt->CMULModNOut(toMul, modN, inStart, outStart, length, controls);
734 engine->CMULModNOut(toMul, modN, inStart, outStart, length, controls);
738 bitLenInt length,
const std::vector<bitLenInt>& controls)
741 qbdt->CIMULModNOut(toMul, modN, inStart, outStart, length, controls);
744 engine->CIMULModNOut(toMul, modN, inStart, outStart, length, controls);
748 bitLenInt length,
const std::vector<bitLenInt>& controls)
751 engine->CPOWModNOut(base, modN, inStart, outStart, length, controls);
755 const unsigned char* values,
bool resetValue =
true)
758 return engine->IndexedLDA(indexStart, indexLength, valueStart, valueLength, values, resetValue);
761 bitLenInt carryIndex,
const unsigned char* values)
764 return engine->IndexedADC(indexStart, indexLength, valueStart, valueLength, carryIndex, values);
767 bitLenInt carryIndex,
const unsigned char* values)
770 return engine->IndexedSBC(indexStart, indexLength, valueStart, valueLength, carryIndex, values);
775 engine->Hash(start, length, values);
781 engine->CPhaseFlipIfLess(greaterPerm, start, length, flagIndex);
786 engine->PhaseFlipIfLess(greaterPerm, start, length);
793 qbdt->Swap(qubitIndex1, qubitIndex2);
795 engine->Swap(qubitIndex1, qubitIndex2);
801 qbdt->ISwap(qubitIndex1, qubitIndex2);
804 engine->ISwap(qubitIndex1, qubitIndex2);
810 qbdt->IISwap(qubitIndex1, qubitIndex2);
813 engine->IISwap(qubitIndex1, qubitIndex2);
819 qbdt->SqrtSwap(qubitIndex1, qubitIndex2);
822 engine->SqrtSwap(qubitIndex1, qubitIndex2);
828 qbdt->ISqrtSwap(qubitIndex1, qubitIndex2);
831 engine->ISqrtSwap(qubitIndex1, qubitIndex2);
837 qbdt->FSim(theta, phi, qubitIndex1, qubitIndex2);
840 engine->FSim(theta, phi, qubitIndex1, qubitIndex2);
847 return qbdt->Prob(qubitIndex);
849 return engine->Prob(qubitIndex);
863 return qbdt->ProbMask(mask, permutation);
865 return engine->ProbMask(mask, permutation);
870 return qbdt->ProbParity(mask);
872 return engine->ProbParity(mask);
877 return qbdt->ForceMParity(mask, result, doForce);
879 return engine->ForceMParity(mask, result, doForce);
885 toCompare->SwitchMode(!
engine);
887 return qbdt->SumSqrDiff(toCompare->qbdt);
889 return engine->SumSqrDiff(toCompare->engine);
895 qbdt->UpdateRunningNorm(norm_thresh);
897 engine->UpdateRunningNorm(norm_thresh);
904 qbdt->NormalizeState(nrm, norm_thresh, phaseArg);
906 engine->NormalizeState(nrm, norm_thresh, phaseArg);
913 return qbdt->ExpectationBitsAll(bits, offset);
915 return engine->ExpectationBitsAll(bits, offset);
920 return qbdt->VarianceBitsAll(bits, offset);
922 return engine->VarianceBitsAll(bits, offset);
937 return qbdt->isFinished();
939 return engine->isFinished();
958 c->qbdt = std::dynamic_pointer_cast<QBdt>(
qbdt->Clone());
960 c->SwitchMode(
false);
961 c->engine->CopyStateVec(
engine);
971 qbdt->SetDevice(dID);
982 return qbdt->GetMaxSize();
984 return engine->GetMaxSize();
double bi_to_double(const BigInteger &in)
Definition: big_integer.hpp:470
unsigned GetConcurrencyLevel()
Definition: parallel_for.hpp:41
A "Qrack::QBdtHybrid" internally switched between Qrack::QBdt and Qrack::QHybrid to maximize entangle...
Definition: qbdthybrid.hpp:26
bitCapInt IndexedADC(bitLenInt indexStart, bitLenInt indexLength, bitLenInt valueStart, bitLenInt valueLength, bitLenInt carryIndex, const unsigned char *values)
Add to entangled 8 bit register state with a superposed index-offset-based read from classical memory...
Definition: qbdthybrid.hpp:760
QBdtHybrid(bitLenInt qBitCount, const bitCapInt &initState=ZERO_BCI, qrack_rand_gen_ptr rgp=nullptr, const complex &phaseFac=CMPLX_DEFAULT_ARG, bool doNorm=false, bool randomGlobalPhase=true, bool useHostMem=false, int64_t deviceId=-1, bool useHardwareRNG=true, bool useSparseStateVec=false, real1_f norm_thresh=REAL1_EPSILON, std::vector< int64_t > devList={}, bitLenInt qubitThreshold=0U, real1_f separation_thresh=_qrack_qunit_sep_thresh)
Definition: qbdthybrid.hpp:127
bitCapInt MAll()
Measure permutation state of all coherent bits.
Definition: qbdthybrid.hpp:510
bool ForceMParity(const bitCapInt &mask, bool result, bool doForce=true)
Act as if is a measurement of parity of the masked set of qubits was applied, except force the (usual...
Definition: qbdthybrid.hpp:874
void Swap(bitLenInt qubitIndex1, bitLenInt qubitIndex2)
Swap values of two bits in register.
Definition: qbdthybrid.hpp:790
bool ForceM(bitLenInt qubit, bool result, bool doForce=true, bool doApply=true)
Act as if is a measurement was applied, except force the (usually random) result.
Definition: qbdthybrid.hpp:502
void MACMtrx(const std::vector< bitLenInt > &controls, const complex *mtrx, bitLenInt target)
Apply an arbitrary single bit unitary transformation, with arbitrary (anti-)control bits.
Definition: qbdthybrid.hpp:374
void INCSC(const bitCapInt &toAdd, bitLenInt start, bitLenInt length, bitLenInt carryIndex)
Add a classical integer to the register, with sign and with (phase-based) carry.
Definition: qbdthybrid.hpp:615
void IMULModNOut(const bitCapInt &toMul, const bitCapInt &modN, bitLenInt inStart, bitLenInt outStart, bitLenInt length)
Inverse of multiplication modulo N by integer, (out of place)
Definition: qbdthybrid.hpp:692
real1_f ACProb(bitLenInt control, bitLenInt target)
Direct measure of bit probability to be in |1> state, if control bit is |0>.
Definition: qbdthybrid.hpp:420
void Mtrx(const complex *mtrx, bitLenInt qubitIndex)
Apply an arbitrary single bit unitary transformation.
Definition: qbdthybrid.hpp:341
void DEC(const bitCapInt &toSub, bitLenInt start, bitLenInt length)
Add integer (without sign)
Definition: qbdthybrid.hpp:549
void CDEC(const bitCapInt &toSub, bitLenInt inOutStart, bitLenInt length, const std::vector< bitLenInt > &controls)
Subtract integer (without sign, with controls)
Definition: qbdthybrid.hpp:557
bitLenInt Compose(QInterfacePtr toCopy)
Combine another QInterface with this one, after the last bit index of this one.
Definition: qbdthybrid.hpp:173
void UniformParityRZ(const bitCapInt &mask, real1_f angle)
If the target qubit set parity is odd, this applies a phase factor of .
Definition: qbdthybrid.hpp:428
bitLenInt ComposeNoClone(QBdtHybridPtr toCopy)
Definition: qbdthybrid.hpp:191
real1_f VarianceBitsAll(const std::vector< bitLenInt > &bits, const bitCapInt &offset=ZERO_BCI)
Direct measure of variance of listed permutation probability.
Definition: qbdthybrid.hpp:917
void UpdateRunningNorm(real1_f norm_thresh=REAL1_DEFAULT_ARG)
Force a calculation of the norm of the state vector, in order to make it unit length before the next ...
Definition: qbdthybrid.hpp:892
bitLenInt Compose(QInterfacePtr toCopy, bitLenInt start)
Compose() a QInterface peer, inserting its qubit into index order at start index.
Definition: qbdthybrid.hpp:187
void MUL(const bitCapInt &toMul, bitLenInt inOutStart, bitLenInt carryStart, bitLenInt length)
Multiply by integer.
Definition: qbdthybrid.hpp:667
void INCDECSC(const bitCapInt &toAdd, bitLenInt start, bitLenInt length, bitLenInt carryIndex)
Common driver method behind INCSC and DECSC (without overflow flag)
Definition: qbdthybrid.hpp:645
bool TryDecompose(bitLenInt start, QInterfacePtr dest, real1_f error_tol=TRYDECOMPOSE_EPSILON)
Attempt to Decompose() a bit range.
Definition: qbdthybrid.hpp:229
real1_f ExpectationBitsAll(const std::vector< bitLenInt > &bits, const bitCapInt &offset=ZERO_BCI)
Get permutation expectation value of bits.
Definition: qbdthybrid.hpp:910
real1_f ProbParity(const bitCapInt &mask)
Overall probability of any odd permutation of the masked set of bits.
Definition: qbdthybrid.hpp:867
void DECSC(const bitCapInt &toSub, bitLenInt start, bitLenInt length, bitLenInt overflowIndex, bitLenInt carryIndex)
Subtract a classical integer from the register, with sign and with carry.
Definition: qbdthybrid.hpp:629
QInterfacePtr MakeSimulator(bool isBdt, const bitCapInt &perm=ZERO_BCI, const complex &phaseFac=CMPLX_DEFAULT_ARG)
Definition: qbdthybrid.cpp:59
QBdtHybrid(std::vector< QInterfaceEngine > eng, bitLenInt qBitCount, const bitCapInt &initState=ZERO_BCI, qrack_rand_gen_ptr rgp=nullptr, const complex &phaseFac=CMPLX_DEFAULT_ARG, bool doNorm=false, bool randomGlobalPhase=true, bool useHostMem=false, int64_t deviceId=-1, bool useHardwareRNG=true, bool useSparseStateVec=false, real1_f norm_thresh=REAL1_EPSILON, std::vector< int64_t > devList={}, bitLenInt qubitThreshold=0U, real1_f separation_thresh=_qrack_qunit_sep_thresh)
Definition: qbdthybrid.cpp:17
void INCDECC(const bitCapInt &toAdd, bitLenInt start, bitLenInt length, bitLenInt carryIndex)
Common driver method behind INCC and DECC (without sign, with carry)
Definition: qbdthybrid.hpp:566
void AntiCSqrtSwap(const std::vector< bitLenInt > &controls, bitLenInt qubit1, bitLenInt qubit2)
Apply a square root of swap with arbitrary (anti) control bits.
Definition: qbdthybrid.hpp:474
void DECSC(const bitCapInt &toSub, bitLenInt start, bitLenInt length, bitLenInt carryIndex)
Subtract a classical integer from the register, with sign and with carry.
Definition: qbdthybrid.hpp:634
void SqrtSwap(bitLenInt qubitIndex1, bitLenInt qubitIndex2)
Square root of Swap gate.
Definition: qbdthybrid.hpp:816
int64_t devID
Definition: qbdthybrid.hpp:36
QBdtPtr qbdt
Definition: qbdthybrid.hpp:37
void Decompose(bitLenInt start, QInterfacePtr dest)
Minimally decompose a set of contiguous bits from the separably composed unit, into "destination".
Definition: qbdthybrid.hpp:225
virtual bitLenInt Compose(QInterfacePtr toCopy)
Combine another QInterface with this one, after the last bit index of this one.
Definition: qinterface.hpp:364
void INCSC(const bitCapInt &toAdd, bitLenInt start, bitLenInt length, bitLenInt overflowIndex, bitLenInt carryIndex)
Add a classical integer to the register, with sign and with carry.
Definition: qbdthybrid.hpp:610
complex phaseFactor
Definition: qbdthybrid.hpp:39
void XMask(const bitCapInt &mask)
Masked X gate.
Definition: qbdthybrid.hpp:396
void NormalizeState(real1_f nrm=REAL1_DEFAULT_ARG, real1_f norm_thresh=REAL1_DEFAULT_ARG, real1_f phaseArg=ZERO_R1_F)
Apply the normalization factor found by UpdateRunningNorm() or on the fly by a single bit gate.
Definition: qbdthybrid.hpp:900
bitLenInt thresholdQubits
Definition: qbdthybrid.hpp:34
bitLenInt ComposeNoClone(QInterfacePtr toCopy)
This is a variant of Compose() for a toCopy argument that will definitely not be reused once "Compose...
Definition: qbdthybrid.hpp:204
void ISwap(bitLenInt qubitIndex1, bitLenInt qubitIndex2)
Swap values of two bits in register, and apply phase factor of i if bits are different.
Definition: qbdthybrid.hpp:798
void Phase(const complex &topLeft, const complex &bottomRight, bitLenInt qubitIndex)
Apply a single bit transformation that only effects phase.
Definition: qbdthybrid.hpp:349
QInterfacePtr Decompose(bitLenInt start, bitLenInt length)
Schmidt decompose a length of qubits.
Definition: qbdthybrid.hpp:209
bitCapIntOcl GetMaxSize()
Definition: qbdthybrid.hpp:979
void CPOWModNOut(const bitCapInt &base, const bitCapInt &modN, bitLenInt inStart, bitLenInt outStart, bitLenInt length, const std::vector< bitLenInt > &controls)
Controlled, raise a classical base to a quantum power, modulo N, (out of place)
Definition: qbdthybrid.hpp:747
std::vector< int64_t > deviceIDs
Definition: qbdthybrid.hpp:40
void INCS(const bitCapInt &toAdd, bitLenInt start, bitLenInt length, bitLenInt overflowIndex)
Add a classical integer to the register, with sign and without carry.
Definition: qbdthybrid.hpp:592
void GetProbs(real1 *outputProbs)
Get the pure quantum state representation.
Definition: qbdthybrid.hpp:308
void DIV(const bitCapInt &toDiv, bitLenInt inOutStart, bitLenInt carryStart, bitLenInt length)
Divide by integer.
Definition: qbdthybrid.hpp:675
virtual void Decompose(bitLenInt start, QInterfacePtr dest)=0
Minimally decompose a set of contiguous bits from the separably composed unit, into "destination".
void SetConcurrency(uint32_t threadCount)
Set the number of threads in parallel for loops, per component QEngine.
Definition: qbdthybrid.hpp:141
real1_f separabilityThreshold
Definition: qbdthybrid.hpp:35
real1_f SumSqrDiff(QInterfacePtr toCompare)
Calculates (1 - <\psi_e|\psi_c>) between states |\psi_c> and |\psi_e>.
Definition: qbdthybrid.hpp:882
void X(bitLenInt q)
Definition: qbdthybrid.hpp:533
bitCapInt IndexedSBC(bitLenInt indexStart, bitLenInt indexLength, bitLenInt valueStart, bitLenInt valueLength, bitLenInt carryIndex, const unsigned char *values)
Subtract from an entangled 8 bit register state with a superposed index-offset-based read from classi...
Definition: qbdthybrid.hpp:766
QInterfacePtr Clone()
Clone this QInterface.
Definition: qbdthybrid.hpp:951
void AntiCSwap(const std::vector< bitLenInt > &controls, bitLenInt qubit1, bitLenInt qubit2)
Apply a swap with arbitrary (anti) control bits.
Definition: qbdthybrid.hpp:456
real1_f Prob(bitLenInt qubitIndex)
Direct measure of bit probability to be in |1> state.
Definition: qbdthybrid.hpp:844
void INCC(const bitCapInt &toAdd, bitLenInt start, bitLenInt length, bitLenInt carryIndex)
Add integer (without sign, with carry)
Definition: qbdthybrid.hpp:583
void PhaseFlipIfLess(const bitCapInt &greaterPerm, bitLenInt start, bitLenInt length)
This is an expedient for an adaptive Grover's search for a function's global minimum.
Definition: qbdthybrid.hpp:783
void MCMtrx(const std::vector< bitLenInt > &controls, const complex *mtrx, bitLenInt target)
Apply an arbitrary single bit unitary transformation, with arbitrary control bits.
Definition: qbdthybrid.hpp:365
real1_f ProbMask(const bitCapInt &mask, const bitCapInt &permutation)
Direct measure of masked permutation probability.
Definition: qbdthybrid.hpp:860
void MULModNOut(const bitCapInt &toMul, const bitCapInt &modN, bitLenInt inStart, bitLenInt outStart, bitLenInt length)
Multiplication modulo N by integer, (out of place)
Definition: qbdthybrid.hpp:683
void ISqrtSwap(bitLenInt qubitIndex1, bitLenInt qubitIndex2)
Inverse square root of Swap gate.
Definition: qbdthybrid.hpp:825
bool M(bitLenInt q)
Definition: qbdthybrid.hpp:525
void SetAmplitude(const bitCapInt &perm, const complex &)
Sets the representational amplitude of a full permutation.
Definition: qbdthybrid.hpp:323
void CMUL(const bitCapInt &toMul, bitLenInt inOutStart, bitLenInt carryStart, bitLenInt length, const std::vector< bitLenInt > &controls)
Controlled multiplication by integer.
Definition: qbdthybrid.hpp:707
void POWModNOut(const bitCapInt &base, const bitCapInt &modN, bitLenInt inStart, bitLenInt outStart, bitLenInt length)
Raise a classical base to a quantum power, modulo N, (out of place)
Definition: qbdthybrid.hpp:701
void Finish()
If asynchronous work is still running, block until it finishes.
Definition: qbdthybrid.hpp:925
void CUniformParityRZ(const std::vector< bitLenInt > &controls, const bitCapInt &mask, real1_f angle)
If the controls are set and the target qubit set parity is odd, this applies a phase factor of .
Definition: qbdthybrid.hpp:437
bool useHostRam
Definition: qbdthybrid.hpp:33
void INCDECSC(const bitCapInt &toAdd, bitLenInt start, bitLenInt length, bitLenInt overflowIndex, bitLenInt carryIndex)
Common driver method behind INCSC and DECSC (with overflow flag)
Definition: qbdthybrid.hpp:639
real1_f SumSqrDiff(QBdtHybridPtr toCompare)
Definition: qbdthybrid.hpp:883
void INCBCD(const bitCapInt &toAdd, bitLenInt start, bitLenInt length)
Add classical BCD integer (without sign)
Definition: qbdthybrid.hpp:651
void CIMULModNOut(const bitCapInt &toMul, const bitCapInt &modN, bitLenInt inStart, bitLenInt outStart, bitLenInt length, const std::vector< bitLenInt > &controls)
Inverse of controlled multiplication modulo N by integer, (out of place)
Definition: qbdthybrid.hpp:737
void INC(const bitCapInt &toAdd, bitLenInt start, bitLenInt length)
Add integer (without sign)
Definition: qbdthybrid.hpp:541
void FSim(real1_f theta, real1_f phi, bitLenInt qubitIndex1, bitLenInt qubitIndex2)
The 2-qubit "fSim" gate, (useful in the simulation of particles with fermionic statistics)
Definition: qbdthybrid.hpp:834
bitLenInt Compose(QBdtHybridPtr toCopy)
Definition: qbdthybrid.hpp:160
void Dump()
If asynchronous work is still running, let the simulator know that it can be aborted.
Definition: qbdthybrid.hpp:942
std::vector< QInterfaceEngine > engines
Definition: qbdthybrid.hpp:41
int64_t GetDevice()
Get the device index.
Definition: qbdthybrid.hpp:977
void Dispose(bitLenInt start, bitLenInt length, const bitCapInt &disposedPerm)
Dispose a a contiguous set of qubits that are already in a permutation eigenstate.
Definition: qbdthybrid.hpp:264
void Dispose(bitLenInt start, bitLenInt length)
Minimally decompose a set of contiguous bits from the separably composed unit, and discard the separa...
Definition: qbdthybrid.hpp:254
real1_f ProbReg(bitLenInt start, bitLenInt length, const bitCapInt &permutation)
Direct measure of register permutation probability.
Definition: qbdthybrid.hpp:151
void CMULModNOut(const bitCapInt &toMul, const bitCapInt &modN, bitLenInt inStart, bitLenInt outStart, bitLenInt length, const std::vector< bitLenInt > &controls)
Controlled multiplication modulo N by integer, (out of place)
Definition: qbdthybrid.hpp:727
void CISqrtSwap(const std::vector< bitLenInt > &controls, bitLenInt qubit1, bitLenInt qubit2)
Apply an inverse square root of swap with arbitrary control bits.
Definition: qbdthybrid.hpp:483
void SwitchMode(bool useBdt)
Switches between QBdt and QEngine modes.
Definition: qbdthybrid.hpp:48
bool useRDRAND
Definition: qbdthybrid.hpp:31
real1_f CProb(bitLenInt control, bitLenInt target)
Direct measure of bit probability to be in |1> state, if control bit is |1>.
Definition: qbdthybrid.hpp:413
void CSqrtSwap(const std::vector< bitLenInt > &controls, bitLenInt qubit1, bitLenInt qubit2)
Apply a square root of swap with arbitrary control bits.
Definition: qbdthybrid.hpp:465
void CheckThreshold()
Definition: qbdthybrid.hpp:71
void SetQuantumState(const complex *inputState)
Set an arbitrary pure quantum state representation.
Definition: qbdthybrid.hpp:292
void SetDevice(int64_t dID)
Set the device index, if more than one device is available.
Definition: qbdthybrid.hpp:967
void DECBCDC(const bitCapInt &toSub, bitLenInt start, bitLenInt length, bitLenInt carryIndex)
Subtract BCD integer (without sign, with carry)
Definition: qbdthybrid.hpp:661
bool TryDecompose(bitLenInt start, QBdtHybridPtr dest, real1_f error_tol=TRYDECOMPOSE_EPSILON)
Definition: qbdthybrid.hpp:233
bitCapInt IndexedLDA(bitLenInt indexStart, bitLenInt indexLength, bitLenInt valueStart, bitLenInt valueLength, const unsigned char *values, bool resetValue=true)
Set 8 bit register bits by a superposed index-offset-based read from classical memory.
Definition: qbdthybrid.hpp:754
void Decompose(bitLenInt start, QBdtHybridPtr dest)
Definition: qbdthybrid.hpp:243
QEnginePtr engine
Definition: qbdthybrid.hpp:38
bool isSparse
Definition: qbdthybrid.hpp:32
void Invert(const complex &topRight, const complex &bottomLeft, bitLenInt qubitIndex)
Apply a single bit transformation that reverses bit probability and might effect phase.
Definition: qbdthybrid.hpp:357
void PhaseParity(real1_f radians, const bitCapInt &mask)
Parity phase gate.
Definition: qbdthybrid.hpp:404
void UniformlyControlledSingleBit(const std::vector< bitLenInt > &controls, bitLenInt qubitIndex, const complex *mtrxs, const std::vector< bitCapInt > mtrxSkipPowers, const bitCapInt &mtrxSkipValueMask)
Definition: qbdthybrid.hpp:385
bitLenInt Compose(QBdtHybridPtr toCopy, bitLenInt start)
Definition: qbdthybrid.hpp:174
void AntiCISqrtSwap(const std::vector< bitLenInt > &controls, bitLenInt qubit1, bitLenInt qubit2)
Apply an inverse square root of swap with arbitrary (anti) control bits.
Definition: qbdthybrid.hpp:492
bool isFinished()
Returns "false" if asynchronous work is still running, and "true" if all previously dispatched asynch...
Definition: qbdthybrid.hpp:934
void CDIV(const bitCapInt &toDiv, bitLenInt inOutStart, bitLenInt carryStart, bitLenInt length, const std::vector< bitLenInt > &controls)
Controlled division by power of integer.
Definition: qbdthybrid.hpp:717
void DECS(const bitCapInt &toAdd, bitLenInt start, bitLenInt length, bitLenInt overflowIndex)
Add a classical integer to the register, with sign and without carry.
Definition: qbdthybrid.hpp:601
complex GetAmplitude(const bitCapInt &perm)
Get the representational amplitude of a full permutation.
Definition: qbdthybrid.hpp:316
void IISwap(bitLenInt qubitIndex1, bitLenInt qubitIndex2)
Inverse ISwap - Swap values of two bits in register, and apply phase factor of -i if bits are differe...
Definition: qbdthybrid.hpp:807
void CINC(const bitCapInt &toAdd, bitLenInt inOutStart, bitLenInt length, const std::vector< bitLenInt > &controls)
Add integer (without sign, with controls)
Definition: qbdthybrid.hpp:574
void INCBCDC(const bitCapInt &toAdd, bitLenInt start, bitLenInt length, bitLenInt carryIndex)
Add classical BCD integer (without sign, with carry)
Definition: qbdthybrid.hpp:656
void Hash(bitLenInt start, bitLenInt length, const unsigned char *values)
Transform a length of qubit register via lookup through a hash table.
Definition: qbdthybrid.hpp:772
bitLenInt Allocate(bitLenInt start, bitLenInt length)
Allocate new "length" count of |0> state qubits at specified qubit index start position.
Definition: qbdthybrid.hpp:276
void GetQuantumState(complex *outputState)
Get the pure quantum state representation.
Definition: qbdthybrid.hpp:300
void SetPermutation(const bitCapInt &perm, const complex &phaseFac=CMPLX_DEFAULT_ARG)
Set to a specific permutation of all qubits.
Definition: qbdthybrid.hpp:331
void CPhaseFlipIfLess(const bitCapInt &greaterPerm, bitLenInt start, bitLenInt length, bitLenInt flagIndex)
The 6502 uses its carry flag also as a greater-than/less-than flag, for the CMP operation.
Definition: qbdthybrid.hpp:778
void DECC(const bitCapInt &toSub, bitLenInt start, bitLenInt length, bitLenInt carryIndex)
Subtract classical integer (without sign, with carry)
Definition: qbdthybrid.hpp:620
real1_f ProbAll(const bitCapInt &fullRegister)
Direct measure of full permutation probability.
Definition: qbdthybrid.hpp:851
void CSwap(const std::vector< bitLenInt > &controls, bitLenInt qubit1, bitLenInt qubit2)
Apply a swap with arbitrary control bits.
Definition: qbdthybrid.hpp:447
A "Qrack::QInterface" is an abstract interface exposing qubit permutation state vector with methods t...
Definition: qinterface.hpp:141
bitCapInt maxQPower
Definition: qinterface.hpp:149
virtual void SetConcurrency(uint32_t threadsPerEngine)
Set the number of threads in parallel for loops, per component QEngine.
Definition: qinterface.hpp:275
real1 amplitudeFloor
Definition: qinterface.hpp:148
virtual bitLenInt Allocate(bitLenInt length)
Allocate new "length" count of |0> state qubits at end of qubit index position.
Definition: qinterface.hpp:470
virtual bitLenInt Compose(QInterfacePtr toCopy)
Combine another QInterface with this one, after the last bit index of this one.
Definition: qinterface.hpp:364
qrack_rand_gen_ptr rand_generator
Definition: qinterface.hpp:150
bool randGlobalPhase
Definition: qinterface.hpp:144
virtual void Decompose(bitLenInt start, QInterfacePtr dest)=0
Minimally decompose a set of contiguous bits from the separably composed unit, into "destination".
virtual void SetQubitCount(bitLenInt qb)
Definition: qinterface.hpp:268
bitLenInt qubitCount
Definition: qinterface.hpp:146
bool doNormalize
Definition: qinterface.hpp:143
Definition: qparity.hpp:22
Half-precision floating-point type.
Definition: half.hpp:2222
virtual void UniformlyControlledSingleBit(const std::vector< bitLenInt > &controls, bitLenInt qubit, const complex *mtrxs)
Apply a "uniformly controlled" arbitrary single bit unitary transformation.
Definition: qinterface.hpp:627
virtual void X(bitLenInt qubit)
X gate.
Definition: qinterface.hpp:1084
virtual void U(bitLenInt target, real1_f theta, real1_f phi, real1_f lambda)
General unitary gate.
Definition: rotational.cpp:18
virtual bool M(bitLenInt qubit)
Measurement gate.
Definition: qinterface.hpp:1013
GLOSSARY: bitLenInt - "bit-length integer" - unsigned integer ID of qubit position in register bitCap...
Definition: complex16x2simd.hpp:25
@ QINTERFACE_OPTIMAL_BASE
Definition: qinterface.hpp:124
std::shared_ptr< QEngine > QEnginePtr
Definition: qrack_types.hpp:151
std::shared_ptr< QInterface > QInterfacePtr
Definition: qinterface.hpp:29
const real1_f _qrack_qunit_sep_thresh
Definition: qrack_functions.hpp:235
QRACK_CONST real1_f TRYDECOMPOSE_EPSILON
Definition: qrack_types.hpp:260
bitLenInt log2Ocl(bitCapIntOcl n)
Definition: qrack_functions.hpp:88
std::shared_ptr< QBdt > QBdtPtr
Definition: qbdt.hpp:30
std::shared_ptr< QBdtHybrid > QBdtHybridPtr
Definition: qbdthybrid.hpp:18
std::complex< real1 > complex
Definition: qrack_types.hpp:128
QRACK_CONST real1 FP_NORM_EPSILON
Definition: qrack_types.hpp:258
QRACK_CONST real1 REAL1_EPSILON
Definition: qrack_types.hpp:200
float real1_f
Definition: qrack_types.hpp:95
QRACK_CONST complex CMPLX_DEFAULT_ARG
Definition: qrack_types.hpp:257
const bitCapInt ZERO_BCI
Definition: qrack_types.hpp:130
bitCapIntOcl pow2Ocl(const bitLenInt &p)
Definition: qrack_functions.hpp:137
uint32 log2(uint32 m, unsigned int n=32)
Fixed point binary logarithm.
Definition: half.hpp:1700
#define REAL1_DEFAULT_ARG
Definition: qrack_types.hpp:177
#define bitLenInt
Definition: qrack_types.hpp:38
#define ZERO_R1_F
Definition: qrack_types.hpp:160
#define qrack_rand_gen_ptr
Definition: qrack_types.hpp:156
#define bitCapInt
Definition: qrack_types.hpp:62
#define bitCapIntOcl
Definition: qrack_types.hpp:50
#define ONE_R1_F
Definition: qrack_types.hpp:163