The Quantum Exact Simulation Toolkit v4.0.0
Loading...
Searching...
No Matches
test_utilities.cpp
1/** @file
2 * Utility functions used by the ported v3 tests of QuEST's deprecated v3 API.
3 *
4 * @author Tyson Jones
5 * @author Oliver Thomson Brown (ported to Catch2 v3)
6 * @author Ali Rezaei (tested porting to QuEST v4)
7 */
8
9#include <catch2/catch_test_macros.hpp>
10#include <catch2/generators/catch_generators.hpp>
11
12#define INCLUDE_DEPRECATED_FUNCTIONS 1
13#define DISABLE_DEPRECATION_WARNINGS 1
14#include "quest/include/quest.h"
15
16#include "test_utilities.hpp"
17
18#include <random>
19#include <vector>
20#include <algorithm>
21#include <bitset>
22
23#if COMPILE_MPI
24
25 #include <mpi.h>
26
27 #if (FLOAT_PRECISION == 1)
28 #define MPI_QCOMP MPI_CXX_FLOAT_COMPLEX
29 #elif (FLOAT_PRECISION == 2)
30 #define MPI_QCOMP MPI_CXX_DOUBLE_COMPLEX
31 #elif (FLOAT_PRECISION == 4) && defined(MPI_CXX_LONG_DOUBLE_COMPLEX)
32 #define MPI_QCOMP MPI_CXX_LONG_DOUBLE_COMPLEX
33 #else
34 #define MPI_QCOMP MPI_C_LONG_DOUBLE_COMPLEX
35 #endif
36
37 #ifdef MPI_MAX_AMPS_IN_MSG
38 #undef MPI_MAX_AMPS_IN_MSG
39 #endif
40 #define MPI_MAX_AMPS_IN_MSG (1 << 30)
41
42#endif
43
44using std::vector;
45
46
47
48/*
49 * resolve reprecated absReal()
50 */
51
52#ifdef absReal
53#undef absReal
54#endif
55
56// not sure where these will go! Maybe into QuEST v itself
57qreal absReal(qreal x) {
58 return abs(x); // TODO: make precision agnostic
59}
60qreal absComp(qcomp x) {
61 return abs(x); // TODO: make precision agnostic
62}
63
64
65
66/* RNG used for generating random test states,
67 * independently used from C's rand() which is
68 * used to generate random test data (e.g. operators)
69 */
70
71static std::mt19937 randomGenerator;
72
73
74
75/* (don't generate doxygen doc)
76 *
77 * preconditions to the internal unit testing functions are checked using
78 * DEMAND rather than Catch2's REQUIRE, so that they are not counted in the
79 * total unit testing statistics (e.g. number of checks passed).
80 */
81#define DEMAND( cond ) if (!(cond)) FAIL( );
82
83QVector operator + (const QVector& v1, const QVector& v2) {
84 DEMAND( v1.size() == v2.size() );
85 QVector out = v1;
86 for (size_t i=0; i<v2.size(); i++)
87 out[i] += v2[i];
88 return out;
89}
90QVector operator - (const QVector& v1, const QVector& v2) {
91 DEMAND( v1.size() == v2.size() );
92 QVector out = v1;
93 for (size_t i=0; i<v2.size(); i++)
94 out[i] -= v2[i];
95 return out;
96}
97QVector operator * (const qcomp& a, const QVector& v) {
98 QVector out = v;
99 for (size_t i=0; i<v.size(); i++)
100 out[i] *= a;
101 return out;
102}
103QVector operator * (const QVector& v, const qcomp& a) {
104 return a * v;
105}
106QVector operator / (const QVector& v, const qcomp& a) {
107 DEMAND( abs(a) != 0 );
108 QVector out = v;
109 for (size_t i=0; i<v.size(); i++)
110 out[i] /= a;
111 return out;
112}
113qcomp operator * (const QVector &v1, const QVector& v2) {
114 // this is sum_i v1_i conj(v2_i)
115 DEMAND( v1.size() == v2.size() );
116 qcomp out = 0;
117 for (size_t i=0; i<v1.size(); i++)
118 out += v1[i] * conj(v2[i]);
119 return out;
120}
121void operator += (QVector& v1, const QVector& v2) { // these violate += returns (fine)
122 v1 = v1 + v2;
123}
124void operator -= (QVector& v1, const QVector& v2) {
125 v1 = v1 - v2;
126}
127void operator *= (QVector& v1, const qcomp& a) {
128 v1 = v1 * a;
129}
130void operator /= (QVector& v1, const qcomp& a) {
131 v1 = v1 / a;
132}
133QMatrix operator + (const QMatrix& m1, const QMatrix& m2) {
134 DEMAND( m1.size() == m2.size() );
135 QMatrix out = m1;
136 for (size_t r=0; r<m1.size(); r++)
137 for (size_t c=0; c<m1.size(); c++)
138 out[r][c] += m2[r][c];
139 return out;
140}
141QMatrix operator - (const QMatrix& m1, const QMatrix& m2) {
142 DEMAND( m1.size() == m2.size() );
143 QMatrix out = m1;
144 for (size_t r=0; r<m1.size(); r++)
145 for (size_t c=0; c<m1.size(); c++)
146 out[r][c] -= m2[r][c];
147 return out;
148}
149QMatrix operator * (const qcomp& a, const QMatrix& m) {
150 QMatrix out = m;
151 for (size_t r=0; r<m.size(); r++)
152 for (size_t c=0; c<m.size(); c++)
153 out[r][c] *= a;
154 return out;
155}
156QMatrix operator * (const QMatrix& m, const qcomp& a) {
157 return a * m;
158}
159QMatrix operator / (const QMatrix& m, const qcomp& a) {
160 QMatrix out = m;
161 for (size_t r=0; r<m.size(); r++)
162 for (size_t c=0; c<m.size(); c++)
163 out[r][c] /= a;
164 return out;
165}
166QMatrix operator * (const QMatrix& m1, const QMatrix& m2) {
167 QMatrix prod = m1; // will be completely overwritten
168 for (size_t r=0; r<m1.size(); r++)
169 for (size_t c=0; c<m1.size(); c++) {
170 prod[r][c] = 0;
171 for (size_t k=0; k<m1.size(); k++)
172 prod[r][c] += m1[r][k] * m2[k][c];
173 }
174 return prod;
175}
176void operator += (QMatrix& m1, const QMatrix& m2) {
177 m1 = m1 + m2;
178}
179void operator -= (QMatrix& m1, const QMatrix& m2) {
180 m1 = m1 - m2;
181}
182void operator *= (QMatrix& m1, const qreal& a) {
183 m1 = m1 * a;
184}
185void operator /= (QMatrix& m1, const qreal& a) {
186 m1 = m1 / a;
187}
188void operator *= (QMatrix& m1, const QMatrix& m2) {
189 m1 = m1 * m2;
190}
191QVector operator * (const QMatrix& m, const QVector& v) {
192 DEMAND( m.size() == v.size() );
193 QVector prod = QVector(v.size());
194 for (size_t r=0; r<v.size(); r++)
195 for (size_t c=0; c<v.size(); c++)
196 prod[r] += m[r][c] * v[c];
197 return prod;
198}
199
201
202 // must seed both rand() and this C++ generator (used for shuffling)
203
204 // obtain a seed from hardware
205 std::random_device cspnrg;
206 unsigned seed = cspnrg();
207
208 // broadcast to ensure node consensus
209#if COMPILE_MPI
210 int sendRank = 0;
211 MPI_Bcast(&seed, 1, MPI_UNSIGNED, sendRank, MPI_COMM_WORLD);
212#endif
213
214 // initilise both C (rand()) and C++ (randomGenerator) RNGs
215 srand(seed);
216 randomGenerator.seed(seed);
217}
218
220 DEMAND( qureg.isDensityMatrix == 0 );
221 DEMAND( qureg.numAmps == (long long int) ref.size() );
222
223 // assert ref is in the debug state (else initDebugState failed)
224 for (size_t i=0; i<ref.size(); i++) {
225 qcomp val = qcomp(.2*i, .2*i+.1);
226 DEMAND( abs(ref[i] - val) < REAL_EPS );
227 }
228
229 // check qureg and ref agree
230 DEMAND( areEqual(qureg, ref) );
231}
232
234 DEMAND( qureg.isDensityMatrix == 1 );
235 DEMAND( (1LL << qureg.numQubits) == (long long int) ref.size() );
236
237 // assert ref is in the (column-wise) debug state (else initDebugState failed)
238 size_t i = 0;
239 for (size_t c=0; c<ref.size(); c++) {
240 for (size_t r=0; r<ref.size(); r++) {
241 qcomp val = qcomp(.2*i, .2*i+.1);
242 DEMAND( abs(ref[r][c] - val) < REAL_EPS );
243 i++;
244 }
245 }
246
247 // check qureg and ref agree
248 DEMAND( areEqual(qureg, ref) );
249}
250
252
253 QVector prod = QVector(a.size() * b.size());
254
255 for (size_t i=0; i<prod.size(); i++)
256 prod[i] = b[i / a.size()] * a[i % a.size()];
257
258 return prod;
259}
260
262 DEMAND( dim > 1 );
263 QMatrix matr = QMatrix(dim);
264 for (size_t i=0; i<dim; i++)
265 matr[i].resize(dim);
266 return matr;
267}
268
270 DEMAND( dim > 1 );
271 QMatrix matr = getZeroMatrix(dim);
272 for (size_t i=0; i<dim; i++)
273 matr[i][i] = 1;
274 return matr;
275}
276
278 DEMAND( ket.size() == bra.size() );
279 QMatrix mat = getZeroMatrix(ket.size());
280
281 for (size_t r=0; r<ket.size(); r++)
282 for (size_t c=0; c<ket.size(); c++)
283 mat[r][c] = ket[r] * conj(bra[c]);
284 return mat;
285}
286
288 QMatrix prod = getZeroMatrix(a.size() * b.size());
289 for (size_t r=0; r<b.size(); r++)
290 for (size_t c=0; c<b.size(); c++)
291 for (size_t i=0; i<a.size(); i++)
292 for (size_t j=0; j<a.size(); j++)
293 prod[r+b.size()*i][c+b.size()*j] = a[i][j] * b[r][c];
294 return prod;
295}
296
297QMatrix getTranspose(QMatrix a) {
298 QMatrix b = a;
299 for (size_t r=0; r<a.size(); r++)
300 for (size_t c=0; c<a.size(); c++)
301 b[r][c] = a[c][r];
302 return b;
303}
304
306 QMatrix b = a;
307 for (size_t r=0; r<a.size(); r++)
308 for (size_t c=0; c<a.size(); c++)
309 b[r][c] = conj(a[c][r]);
310 return b;
311}
312
314
315 // ensure diagonal
316 for (size_t r=0; r<a.size(); r++)
317 for (size_t c=0; c<a.size(); c++) {
318 if (r == c)
319 continue;
320 DEMAND( real(a[r][c]) == 0. );
321 DEMAND( imag(a[r][c]) == 0. );
322 }
323
324 // exp(diagonal) = diagonal(exp)
325 QMatrix diag = a;
326 for (size_t i=0; i<a.size(); i++)
327 diag[i][i] = exp(diag[i][i]);
328
329 return diag;
330}
331
333 QMatrix iden = getIdentityMatrix(a.size());
334 QMatrix expo = (cos(angle/2) * iden) + ((qcomp) -1i * sin(angle/2) * a);
335 return expo;
336}
337
338void setSubMatrix(QMatrix &dest, QMatrix sub, size_t r, size_t c) {
339 DEMAND( sub.size() + r <= dest.size() );
340 DEMAND( sub.size() + c <= dest.size() );
341 for (size_t i=0; i<sub.size(); i++)
342 for (size_t j=0; j<sub.size(); j++)
343 dest[r+i][c+j] = sub[i][j];
344}
345
346QMatrix getSwapMatrix(int qb1, int qb2, int numQb) {
347 DEMAND( numQb > 1 );
348 DEMAND( (qb1 >= 0 && qb1 < numQb) );
349 DEMAND( (qb2 >= 0 && qb2 < numQb) );
350
351 if (qb1 > qb2)
352 std::swap(qb1, qb2);
353
354 if (qb1 == qb2)
355 return getIdentityMatrix(1 << numQb);
356
357 QMatrix swap;
358
359 if (qb2 == qb1 + 1) {
360 // qubits are adjacent
361 swap = QMatrix{{1,0,0,0},{0,0,1,0},{0,1,0,0},{0,0,0,1}};
362
363 } else {
364 // qubits are distant
365 int block = 1 << (qb2 - qb1);
366 swap = getZeroMatrix(block*2);
367 QMatrix iden = getIdentityMatrix(block/2);
368
369 // Lemma 3.1 of arxiv.org/pdf/1711.09765.pdf
370 QMatrix p0{{1,0},{0,0}};
371 QMatrix l0{{0,1},{0,0}};
372 QMatrix l1{{0,0},{1,0}};
373 QMatrix p1{{0,0},{0,1}};
374
375 /* notating a^(n+1) = identity(1<<n) (otimes) a, we construct the matrix
376 * [ p0^(N) l1^N ]
377 * [ l0^(N) p1^N ]
378 * where N = qb2 - qb1 */
379 setSubMatrix(swap, getKroneckerProduct(iden, p0), 0, 0);
380 setSubMatrix(swap, getKroneckerProduct(iden, l0), block, 0);
381 setSubMatrix(swap, getKroneckerProduct(iden, l1), 0, block);
382 setSubMatrix(swap, getKroneckerProduct(iden, p1), block, block);
383 }
384
385 // pad swap with outer identities
386 if (qb1 > 0)
387 swap = getKroneckerProduct(swap, getIdentityMatrix(1<<qb1));
388 if (qb2 < numQb-1)
389 swap = getKroneckerProduct(getIdentityMatrix(1<<(numQb-qb2-1)), swap);
390
391 return swap;
392}
393
394/* (don't generate doxygen doc)
395 *
396 * iterates list1 (of length len1) and replaces element oldEl with newEl, which is
397 * gauranteed to be present at most once (between list1 AND list2), though may
398 * not be present at all. If oldEl isn't present in list1, does the same for list2.
399 * list1 is skipped if == NULL. This is used by getFullOperatorMatrix() to ensure
400 * that, when qubits are swapped, their appearences in the remaining qubit lists
401 * are updated.
402 */
403void updateIndices(int oldEl, int newEl, int* list1, int len1, int* list2, int len2) {
404 if (list1 != NULL) {
405 for (int i=0; i<len1; i++) {
406 if (list1[i] == oldEl) {
407 list1[i] = newEl;
408 return;
409 }
410 }
411 }
412 for (int i=0; i<len2; i++) {
413 if (list2[i] == oldEl) {
414 list2[i] = newEl;
415 return;
416 }
417 }
418}
419
421 int* ctrls, int numCtrls, int *targs, int numTargs, QMatrix op, int numQubits
422) {
423 DEMAND( numCtrls >= 0 );
424 DEMAND( numTargs >= 0 );
425 DEMAND( numQubits >= (numCtrls+numTargs) );
426 DEMAND( op.size() == (1u << numTargs) );
427
428 // copy {ctrls} and {targs}to restore at end
429 vector<int> ctrlsCopy(ctrls, ctrls+numCtrls);
430 vector<int> targsCopy(targs, targs+numTargs);
431
432 // full-state matrix of qubit swaps
433 QMatrix swaps = getIdentityMatrix(1 << numQubits);
434 QMatrix unswaps = getIdentityMatrix(1 << numQubits);
435 QMatrix matr;
436
437 // swap targs to {0, ..., numTargs-1}
438 for (int i=0; i<numTargs; i++) {
439 if (i != targs[i]) {
440 matr = getSwapMatrix(i, targs[i], numQubits);
441 swaps = matr * swaps;
442 unswaps = unswaps * matr;
443
444 // even if this is the last targ, ctrls might still need updating
445 updateIndices(
446 i, targs[i], (i < numTargs-1)? &targs[i+1] : NULL,
447 numTargs-i-1, ctrls, numCtrls);
448 }
449 }
450
451 // swap ctrls to {numTargs, ..., numTargs+numCtrls-1}
452 for (int i=0; i<numCtrls; i++) {
453 int newInd = numTargs+i;
454 if (newInd != ctrls[i]) {
455 matr = getSwapMatrix(newInd, ctrls[i], numQubits);
456 swaps = matr * swaps;
457 unswaps = unswaps * matr;
458
459 // update remaining ctrls (if any exist)
460 if (i < numCtrls-1)
461 updateIndices(newInd, ctrls[i], NULL, 0, &ctrls[i+1], numCtrls-i-1);
462 }
463 }
464
465 // construct controlled-op matrix for qubits {0, ..., numCtrls+numTargs-1}
466 size_t dim = 1 << (numCtrls+numTargs);
467 QMatrix fullOp = getIdentityMatrix(dim);
468 setSubMatrix(fullOp, op, dim-op.size(), dim-op.size());
469
470 // create full-state controlled-op matrix (left-pad identities)
471 if (numQubits > numCtrls+numTargs) {
472 size_t pad = 1 << (numQubits - numCtrls - numTargs);
473 fullOp = getKroneckerProduct(getIdentityMatrix(pad), fullOp);
474 }
475
476 // apply swap to either side (to swap qubits back and forth)
477 fullOp = unswaps * fullOp * swaps;
478
479 // restore {ctrls and targs}
480 for (int i=0; i<numCtrls; i++)
481 ctrls[i] = ctrlsCopy[i];
482 for (int i=0; i<numTargs; i++)
483 targs[i] = targsCopy[i];
484
485 return fullOp;
486}
487
488unsigned int calcLog2(long unsigned int res) {
489 unsigned int n = 0;
490 while (res >>= 1)
491 n++;
492 return n;
493}
494
496 DEMAND( dim > 1 );
497
498 QMatrix matr = getZeroMatrix(dim);
499 for (int i=0; i<dim; i++) {
500 for (int j=0; j<dim; j++) {
501
502 // generate 2 normally-distributed random numbers via Box-Muller
503 qreal a = rand()/(qreal) RAND_MAX;
504 qreal b = rand()/(qreal) RAND_MAX;
505 if (a == 0) a = REAL_EPS; // prevent rand()=0 creation of NaN
506 qreal r1 = sqrt(-2 * log(a)) * cos(2 * 3.14159265 * b);
507 qreal r2 = sqrt(-2 * log(a)) * sin(2 * 3.14159265 * b);
508
509 matr[i][j] = r1 + r2 * (qcomp) 1i;
510 }
511 }
512 return matr;
513}
514
516 DEMAND( a.size() == b.size() );
517
518 for (size_t i=0; i<a.size(); i++)
519 if (abs(a[i] - b[i]) > REAL_EPS)
520 return false;
521 return true;
522}
523
525 DEMAND( a.size() == b.size() );
526
527 for (size_t i=0; i<a.size(); i++)
528 for (size_t j=0; j<b.size(); j++)
529 if (abs(a[i][j] - b[i][j]) > REAL_EPS)
530 return false;
531 return true;
532}
533
534qcomp expI(qreal phase) {
535 return qcomp(cos(phase), sin(phase));
536}
537
538qreal getRandomReal(qreal min, qreal max) {
539 DEMAND( min <= max );
540 qreal r = min + (max - min) * (rand() / (qreal) RAND_MAX);
541
542 // check bounds satisfied
543 DEMAND( r >= min );
544 DEMAND( r <= max );
545 return r;
546}
547
549 return getRandomReal(-1,1) + getRandomReal(-1,1) * (qcomp) 1i;
550}
551
553 QVector vec = QVector(dim);
554 for (int i=0; i<dim; i++)
555 vec[i] = getRandomComplex();
556
557 return vec;
558}
559
561
562 // compute the vec norm via Kahan summation to suppress numerical error
563 qreal norm = 0;
564 qreal y, t, c;
565 c = 0;
566
567 for (size_t i=0; i<vec.size(); i++) {
568 y = real(vec[i])*real(vec[i]) - c;
569 t = norm + y;
570 c = ( t - norm ) - y;
571 norm = t;
572
573 y = imag(vec[i])*imag(vec[i]) - c;
574 t = norm + y;
575 c = ( t - norm ) - y;
576 norm = t;
577 }
578
579 for (size_t i=0; i<vec.size(); i++)
580 vec[i] /= sqrt(norm);
581 return vec;
582}
583
585 return getNormalised(getRandomQVector(1<<numQb));
586}
587
588vector<qreal> getRandomProbabilities(int numProbs) {
589
590 // generate random unnormalised scalars
591 vector<qreal> probs;
592 qreal total = 0;
593 for (int i=0; i<numProbs; i++) {
594 qreal prob = getRandomReal(0, 1);
595 probs.push_back(prob);
596 total += prob;
597 }
598
599 // normalise
600 for (int i=0; i<numProbs; i++)
601 probs[i] /= total;
602
603 return probs;
604}
605
607 DEMAND( numQb > 0 );
608
609 // generate random probabilities to weight random pure states
610 int dim = 1<<numQb;
611 vector<qreal> probs = getRandomProbabilities(dim);
612
613 // add random pure states
614 QMatrix dens = getZeroMatrix(dim);
615 for (int i=0; i<dim; i++) {
616 QVector pure = getRandomStateVector(numQb);
617 dens += probs[i] * getKetBra(pure, pure);
618 }
619
620 return dens;
621}
622
624 return getKetBra(state, state);
625}
626
628 QVector vec = getRandomStateVector(numQb);
629 QMatrix mat = getPureDensityMatrix(vec);
630 return mat;
631}
632
634
635 QVector vec = QVector(matr.size());
636 for (size_t i=0; i<vec.size(); i++)
637 vec[i] = matr[i][i];
638
639 return vec;
640}
641
642int getRandomInt(int min, int max) {
643 return (int) round(getRandomReal(min, max-1));
644}
645
646QMatrix getOrthonormalisedRows(QMatrix matr) {
647
648 // perform the Gram-Schmidt process, processing each row of matr in-turn
649 for (size_t i=0; i<matr.size(); i++) {
650 QVector row = matr[i];
651
652 // compute new orthogonal row by subtracting proj row onto prevs
653 for (int k=i-1; k>=0; k--) {
654
655 // compute inner_product(row, prev) = row . conj(prev)
656 qcomp prod = row * matr[k];
657
658 // subtract (proj row onto prev) = (prod * prev) from final row
659 matr[i] -= prod * matr[k];
660 }
661
662 // normalise the row
663 matr[i] = getNormalised(matr[i]);
664 }
665
666 // return the new orthonormal matrix
667 return matr;
668}
669
670QMatrix getRandomDiagonalUnitary(int numQb) {
671 DEMAND( numQb >= 1 );
672
673 QMatrix matr = getZeroMatrix(1 << numQb);
674 for (size_t i=0; i<matr.size(); i++)
675 matr[i][i] = expI(getRandomReal(0,4*M_PI));
676
677 return matr;
678}
679
681 DEMAND( numQb >= 1 );
682
683 // create Z ~ random complex matrix (distribution not too important)
684 size_t dim = 1 << numQb;
685 QMatrix matrZ = getRandomQMatrix(dim);
686 QMatrix matrZT = getTranspose(matrZ);
687
688 // create Z = Q R (via QR decomposition) ...
689 QMatrix matrQT = getOrthonormalisedRows(matrZ);
690 QMatrix matrQ = getTranspose(matrQT);
691 QMatrix matrR = getZeroMatrix(dim);
692
693 // ... where R_rc = (columm c of Z) . (column r of Q) = (row c of ZT) . (row r of QT)
694 for (size_t r=0; r<dim; r++)
695 for (size_t c=r; c<dim; c++)
696 matrR[r][c] = matrZT[c] * matrQT[r];
697
698 // create D = normalised diagonal of R
699 QMatrix matrD = getZeroMatrix(dim);
700 for (size_t i=0; i<dim; i++)
701 matrD[i][i] = matrR[i][i] / abs(matrR[i][i]);
702
703 // create U = Q D
704 QMatrix matrU = matrQ * matrD;
705
706 // in the rare scenario the result is not sufficiently precisely unitary,
707 // replace it with a trivially unitary diagonal matrix
708 QMatrix daggerProd = matrU * getConjugateTranspose(matrU);
709 QMatrix iden = getIdentityMatrix(dim);
710 if( ! areEqual(daggerProd, iden) )
711 matrU = getRandomDiagonalUnitary(numQb);
712
713 return matrU;
714}
715
716vector<QMatrix> getRandomKrausMap(int numQb, int numOps) {
717 DEMAND( numOps >= 1 );
718 DEMAND( numOps <= 4*numQb*numQb );
719
720 // generate random unitaries
721 vector<QMatrix> ops;
722 for (int i=0; i<numOps; i++)
723 ops.push_back(getRandomUnitary(numQb));
724
725 // generate random weights
726 vector<qreal> weights(numOps);
727 for (int i=0; i<numOps; i++)
728 weights[i] = getRandomReal(0, 1);
729
730 // normalise random weights
731 qreal weightSum = 0;
732 for (int i=0; i<numOps; i++)
733 weightSum += weights[i];
734 for (int i=0; i<numOps; i++)
735 weights[i] = sqrt((qreal) weights[i]/weightSum);
736
737 // normalise ops
738 for (int i=0; i<numOps; i++)
739 ops[i] *= weights[i];
740
741 // check what we produced was a valid Kraus map
742 QMatrix iden = getIdentityMatrix(1 << numQb);
743 QMatrix prodSum = getZeroMatrix(1 << numQb);
744 for (int i=0; i<numOps; i++)
745 prodSum += getConjugateTranspose(ops[i]) * ops[i];
746
747 // in the rare scenario it is insufficiently numerically precise,
748 // replace the map with trivially precise diagonals
749 if( ! areEqual(prodSum, iden) )
750 for (int i=0; i<numOps; i++)
751 ops[i] = weights[i] * getRandomDiagonalUnitary(numQb);
752
753 return ops;
754}
755
756vector<QVector> getRandomOrthonormalVectors(int numQb, int numStates) {
757 DEMAND( numQb >= 1 );
758 DEMAND( numStates >= 1);
759
760 // set of orthonormal vectors
761 vector<QVector> vecs;
762
763 for (int n=0; n<numStates; n++) {
764
765 QVector vec = getRandomStateVector(numQb);
766
767 // orthogonalise by substracting projections of existing vectors
768 for (int m=0; m<n; m++) {
769 qcomp prod = vec * vecs[m];
770 vec -= (prod * vecs[m]);
771 }
772
773 // renormalise
774 vec = getNormalised(vec);
775
776 // add to orthonormal set
777 vecs.push_back(vec);
778 }
779
780 return vecs;
781}
782
783QMatrix getMixedDensityMatrix(vector<qreal> probs, vector<QVector> states) {
784 DEMAND( probs.size() == states.size() );
785 DEMAND( probs.size() >= 1 );
786
787 QMatrix matr = getZeroMatrix(states[0].size());
788
789 for (size_t i=0; i<probs.size(); i++)
790 matr += probs[i] * getPureDensityMatrix(states[i]);
791
792 return matr;
793}
794
796 REQUIRE( in.size() > 0 );
797
798 size_t dim = in.size();
799 qreal ampFac = 1 / sqrt( dim );
800 qreal phaseFac = 2 * M_PI / dim;
801
802 QVector dftVec = QVector(dim);
803
804 for (size_t x=0; x<dim; x++) {
805 dftVec[x] = 0;
806 for (size_t y=0; y<dim; y++)
807 dftVec[x] += expI(phaseFac * x * y) * in[y];
808 dftVec[x] *= ampFac;
809 }
810 return dftVec;
811}
812
813long long int getValueOfTargets(long long int ind, int* targs, int numTargs) {
814 DEMAND( ind >= 0 );
815
816 long long int val = 0;
817
818 for (int t=0; t<numTargs; t++)
819 val += ((ind >> targs[t]) & 1) * (1LL << t);
820
821 return val;
822}
823
824long long int setBit(long long int num, int bitInd, int bitVal) {
825 DEMAND( (bitVal == 0 || bitVal == 1) );
826 DEMAND( num >= 0 );
827 DEMAND( bitInd >= 0 );
828
829 return (num & ~(1UL << bitInd)) | (bitVal << bitInd);
830}
831
832long long int getIndexOfTargetValues(long long int ref, int* targs, int numTargs, long long int targVal) {
833 // ref state is the starting index, where the targets can be in any bit state;
834 // on the bits of the non-target qubits matter
835
836 for (int t=0; t<numTargs; t++) {
837 int bit = (targVal >> t) & 1;
838 ref = setBit(ref, targs[t], bit);
839 }
840 return ref;
841}
842
843QVector getDFT(QVector in, int* targs, int numTargs) {
844
845 QVector out = QVector(in.size());
846 long long int inDim = (long long int) in.size();
847 long long int targDim = (1LL << numTargs);
848
849 for (long long int j=0; j<inDim; j++) {
850
851 // |j> = |x> (x) |...>, but mixed (not separated)
852 long long int x = getValueOfTargets(j, targs, numTargs);
853
854 for (long long int y=0; y<targDim; y++) {
855
856 // modifies sum_y |y> (x) ...
857 long long int outInd = getIndexOfTargetValues(j, targs, numTargs, y);
858
859 qcomp elem = (in[j] / sqrt(pow(2,numTargs))) * expI(2*M_PI * x * y / pow(2,numTargs));
860 out[outInd] += elem;
861 }
862 }
863
864 return out;
865}
866
867/* (do not generate doxygen doc)
868 *
869 * Overloads for applyReferenceOp, to conveniently specify all families of
870 * unitary operations on state-vectors.
871 */
873 QVector &state, int* ctrls, int numCtrls, int *targs, int numTargs, QMatrix op
874) {
875 int numQubits = calcLog2(state.size());
876 QMatrix fullOp = getFullOperatorMatrix(ctrls, numCtrls, targs, numTargs, op, numQubits);
877 state = fullOp * state;
878}
880 QVector &state, int* ctrls, int numCtrls, int targ1, int targ2, QMatrix op
881) {
882 int targs[2] = {targ1, targ2};
883 applyReferenceOp(state, ctrls, numCtrls, targs, 2, op);
884}
886 QVector &state, int* ctrls, int numCtrls, int target, QMatrix op
887) {
888 int targs[1] = {target};
889 applyReferenceOp(state, ctrls, numCtrls, targs, 1, op);
890}
892 QVector &state, int *targs, int numTargs, QMatrix op
893) {
894 applyReferenceOp(state, NULL, 0, targs, numTargs, op);
895}
897 QVector &state, int ctrl, int targ, QMatrix op
898) {
899 int ctrls[1] = {ctrl};
900 int targs[1] = {targ};
901 applyReferenceOp(state, ctrls, 1, targs, 1, op);
902}
904 QVector &state, int ctrl, int* targs, int numTargs, QMatrix op
905) {
906 int ctrls[1] = {ctrl};
907 applyReferenceOp(state, ctrls, 1, targs, numTargs, op);
908}
910 QVector &state, int ctrl, int targ1, int targ2, QMatrix op
911) {
912 int ctrls[1] = {ctrl};
913 int targs[2] = {targ1, targ2};
914 applyReferenceOp(state, ctrls, 1, targs, 2, op);
915}
917 QVector &state, int targ, QMatrix op
918) {
919 int targs[1] = {targ};
920 applyReferenceOp(state, NULL, 0, targs, 1, op);
921}
922
923/* (do not generate doxygen doc)
924 *
925 * Overloads for applyReferenceOp, to conveniently specify all families of
926 * unitary operations on state-vectors.
927 */
929 QMatrix &state, int* ctrls, int numCtrls, int *targs, int numTargs, QMatrix op
930) {
931 int numQubits = calcLog2(state.size());
932 QMatrix leftOp = getFullOperatorMatrix(ctrls, numCtrls, targs, numTargs, op, numQubits);
933 QMatrix rightOp = getConjugateTranspose(leftOp);
934 state = leftOp * state * rightOp;
935}
937 QMatrix &state, int* ctrls, int numCtrls, int targ1, int targ2, QMatrix op
938) {
939 int targs[2] = {targ1, targ2};
940 applyReferenceOp(state, ctrls, numCtrls, targs, 2, op);
941}
943 QMatrix &state, int* ctrls, int numCtrls, int target, QMatrix op
944) {
945 int targs[1] = {target};
946 applyReferenceOp(state, ctrls, numCtrls, targs, 1, op);
947}
949 QMatrix &state, int *targs, int numTargs, QMatrix op
950) {
951 applyReferenceOp(state, NULL, 0, targs, numTargs, op);
952}
954 QMatrix &state, int ctrl, int targ, QMatrix op
955) {
956 int ctrls[1] = {ctrl};
957 int targs[1] = {targ};
958 applyReferenceOp(state, ctrls, 1, targs, 1, op);
959}
961 QMatrix &state, int ctrl, int* targs, int numTargs, QMatrix op
962) {
963 int ctrls[1] = {ctrl};
964 applyReferenceOp(state, ctrls, 1, targs, numTargs, op);
965}
967 QMatrix &state, int ctrl, int targ1, int targ2, QMatrix op
968) {
969 int ctrls[1] = {ctrl};
970 int targs[2] = {targ1, targ2};
971 applyReferenceOp(state, ctrls, 1, targs, 2, op);
972}
974 QMatrix &state, int targ, QMatrix op
975) {
976 int targs[1] = {targ};
977 applyReferenceOp(state, NULL, 0, targs, 1, op);
978}
979
980/* (do not generate doxygen doc)
981 *
982 * Overloads for applyReferenceMatrix, to simply left-multiply a matrix (possibly
983 * with additional control qubits) onto a state.
984 */
986 QVector &state, int* ctrls, int numCtrls, int *targs, int numTargs, QMatrix op
987) {
988 // for state-vectors, the op is always just left-multiplied
989 applyReferenceOp(state, ctrls, numCtrls, targs, numTargs, op);
990}
992 QVector &state, int *targs, int numTargs, QMatrix op
993) {
994 // for state-vectors, the op is always just left-multiplied
995 applyReferenceOp(state, targs, numTargs, op);
996}
998 QMatrix &state, int* ctrls, int numCtrls, int *targs, int numTargs, QMatrix op
999) {
1000 // for density matrices, op is left-multiplied only
1001 int numQubits = calcLog2(state.size());
1002 QMatrix leftOp = getFullOperatorMatrix(ctrls, numCtrls, targs, numTargs, op, numQubits);
1003 state = leftOp * state;
1004}
1006 QMatrix &state, int *targs, int numTargs, QMatrix op
1007) {
1008 applyReferenceMatrix(state, NULL, 0, targs, numTargs, op);
1009}
1010
1011bool areEqual(Qureg qureg1, Qureg qureg2, qreal precision) {
1012 DEMAND( qureg1.isDensityMatrix == qureg2.isDensityMatrix );
1013 DEMAND( qureg1.numAmps == qureg2.numAmps );
1014
1015 copyStateFromGPU(qureg1);
1016 copyStateFromGPU(qureg2);
1017 syncQuESTEnv();
1018
1019 // loop terminates when areEqual = 0
1020 int ampsAgree = 1;
1021 for (long long int i=0; ampsAgree && i<qureg1.numAmpsPerNode; i++)
1022 ampsAgree = absComp(qureg1.cpuAmps[i] - qureg2.cpuAmps[i]) < precision;
1023
1024 // if one node's partition wasn't equal, all-nodes must report not-equal
1025 int allAmpsAgree = ampsAgree;
1026#if COMPILE_MPI
1027 MPI_Allreduce(&ampsAgree, &allAmpsAgree, 1, MPI_INT, MPI_LAND, MPI_COMM_WORLD);
1028#endif
1029
1030 return allAmpsAgree;
1031}
1032bool areEqual(Qureg qureg1, Qureg qureg2) {
1033 return areEqual(qureg1, qureg2, REAL_EPS);
1034}
1035
1036bool areEqual(Qureg qureg, QVector vec, qreal precision) {
1037 DEMAND( !qureg.isDensityMatrix );
1038 DEMAND( (int) vec.size() == qureg.numAmps );
1039
1040 copyStateFromGPU(qureg);
1041 syncQuESTEnv();
1042
1043 // the starting index in vec of this node's qureg partition.
1044 long long int startInd = qureg.rank * qureg.numAmpsPerNode;
1045
1046 int ampsAgree = 1;
1047 for (long long int i=0; i<qureg.numAmpsPerNode; i++) {
1048 qcomp dif = (qureg.cpuAmps[i] - vec[startInd+i]);
1049
1050 if (absComp(dif) > precision) {
1051 ampsAgree = 0;
1052
1053 // debug
1054 char buff[200];
1055 snprintf(buff, 200, "Disagreement at %lld of (%s) + i(%s):\n\t%s + i(%s) VS %s + i(%s)\n",
1056 startInd+i,
1057 QREAL_FORMAT_SPECIFIER, QREAL_FORMAT_SPECIFIER, QREAL_FORMAT_SPECIFIER,
1058 QREAL_FORMAT_SPECIFIER, QREAL_FORMAT_SPECIFIER, QREAL_FORMAT_SPECIFIER);
1059 printf(buff,
1060 real(dif), imag(dif),
1061 real(qureg.cpuAmps[i]), imag(qureg.cpuAmps[i]),
1062 real(vec[startInd+i]), imag(vec[startInd+i]));
1063
1064 break;
1065 }
1066 }
1067
1068 // if one node's partition wasn't equal, all-nodes must report not-equal
1069 int allAmpsAgree = ampsAgree;
1070#if COMPILE_MPI
1071 MPI_Allreduce(&ampsAgree, &allAmpsAgree, 1, MPI_INT, MPI_LAND, MPI_COMM_WORLD);
1072#endif
1073
1074 return allAmpsAgree;
1075}
1076bool areEqual(Qureg qureg, QVector vec) {
1077 return areEqual(qureg, vec, REAL_EPS);
1078}
1079
1080bool areEqual(Qureg qureg, QMatrix matr, qreal precision) {
1081 DEMAND( qureg.isDensityMatrix );
1082 DEMAND( (long long int) (matr.size()*matr.size()) == qureg.numAmps );
1083
1084 // ensure local qureg amps is up to date
1085 copyStateFromGPU(qureg);
1086 syncQuESTEnv();
1087
1088 // the starting index in vec of this node's qureg partition.
1089 long long int startInd = qureg.rank * qureg.numAmpsPerNode;
1090 long long int globalInd, row, col, i;
1091 int ampsAgree;
1092
1093 // compare each of this node's amplitude to the corresponding matr sub-matrix
1094 for (i=0; i<qureg.numAmpsPerNode; i++) {
1095 globalInd = startInd + i;
1096 row = globalInd % matr.size();
1097 col = globalInd / matr.size();
1098
1099 qreal realDif = absReal(real(qureg.cpuAmps[i]) - real(matr[row][col]));
1100 qreal imagDif = absReal(imag(qureg.cpuAmps[i]) - imag(matr[row][col]));
1101 ampsAgree = (realDif < precision && imagDif < precision);
1102
1103 // DEBUG
1104 if (!ampsAgree) {
1105 char buff[200];
1106 snprintf(buff, 200, "[msg from utilities.cpp] node %d has a disagreement at %lld of (%s) + i(%s):\n\t[qureg] %s + i(%s) VS [ref] %s + i(%s)\n",
1107 qureg.rank, startInd+i,
1108 QREAL_FORMAT_SPECIFIER, QREAL_FORMAT_SPECIFIER, QREAL_FORMAT_SPECIFIER,
1109 QREAL_FORMAT_SPECIFIER, QREAL_FORMAT_SPECIFIER, QREAL_FORMAT_SPECIFIER);
1110 printf(buff,
1111 realDif, imagDif,
1112 real(qureg.cpuAmps[i]), imag(qureg.cpuAmps[i]),
1113 real(matr[row][col]), imag(matr[row][col]));
1114 }
1115
1116 // break loop as soon as amplitudes disagree
1117 if (!ampsAgree)
1118 break;
1119
1120 /* TODO:
1121 * of the nodes which disagree, the lowest-rank should send its
1122 * disagreeing (i, row, col, stateVec[i]) to rank 0 which should
1123 * report it immediately (before the impending DEMAND failure)
1124 * using FAIL_CHECK, so users can determine nature of disagreement
1125 * (e.g. numerical precision).
1126 * Note FAIL_CHECK accepts << like cout, e.g.
1127 * FAIL_CHECK( "Amp at (" << row << ", " << col ") disagreed" );
1128 */
1129 }
1130
1131 // if one node's partition wasn't equal, all-nodes must report not-equal
1132 int allAmpsAgree = ampsAgree;
1133#if COMPILE_MPI
1134 MPI_Allreduce(&ampsAgree, &allAmpsAgree, 1, MPI_INT, MPI_LAND, MPI_COMM_WORLD);
1135#endif
1136
1137 return allAmpsAgree;
1138}
1139bool areEqual(Qureg qureg, QMatrix matr) {
1140 return areEqual(qureg, matr, REAL_EPS);
1141}
1142
1143bool areEqual(QVector vec, qreal* reals, qreal* imags) {
1144
1145 qreal dif;
1146 for (size_t i=0; i<vec.size(); i++) {
1147 dif = absReal(real(vec[i]) - reals[i]);
1148 if (dif > REAL_EPS)
1149 return false;
1150 dif = absReal(imag(vec[i]) - imags[i]);
1151 if (dif > REAL_EPS)
1152 return false;
1153 }
1154 return true;
1155}
1156
1157bool areEqual(QVector vec, qreal* reals) {
1158 for (size_t i=0; i<vec.size(); i++) {
1159 DEMAND( imag(vec[i]) == 0. );
1160
1161 qreal dif = abs(real(vec[i]) - reals[i]);
1162 if (dif > REAL_EPS)
1163 return false;
1164 }
1165 return true;
1166}
1167
1168/* Copies QMatrix into a CompelxMAtrix struct */
1169#define macro_copyQMatrixToDeprecatedComplexMatrix(dest, src) { \
1170 for (size_t i=0; i<src.size(); i++) { \
1171 for (size_t j=0; j<src.size(); j++) { \
1172 dest.real[i][j] = real(src[i][j]); \
1173 dest.imag[i][j] = imag(src[i][j]); \
1174 } \
1175 } \
1176}
1178 DEMAND( qm.size() == 2 );
1179 ComplexMatrix2 cm;
1180 macro_copyQMatrixToDeprecatedComplexMatrix(cm, qm);
1181 return cm;
1182}
1184 DEMAND( qm.size() == 4 );
1185 ComplexMatrix4 cm;
1186 macro_copyQMatrixToDeprecatedComplexMatrix(cm, qm);
1187 return cm;
1188}
1189
1190/** Copies ComplexMatrix structures into a QMatrix */
1191#define macro_copyComplexMatrix(dest, src, dim) \
1192 for (size_t i=0; i<dim; i++) \
1193 for (size_t j=0; j<dim; j++) \
1194 dest[i][j] = src[i][j];
1195
1196void toComplexMatrixN(QMatrix qm, ComplexMatrixN cm) {
1197 DEMAND( qm.size() == (1u<<cm.numQubits) );
1198 macro_copyComplexMatrix(cm.cpuElems, qm, qm.size());
1199 syncCompMatr(cm);
1200}
1201
1203 QMatrix dest = getZeroMatrix(2);
1204 macro_copyComplexMatrix(dest, src.elems, dest.size());
1205 return dest;
1206}
1208 QMatrix dest = getZeroMatrix(4);
1209 macro_copyComplexMatrix(dest, src.elems, dest.size());
1210 return dest;
1211}
1213 QMatrix dest = getZeroMatrix(1 << src.numQubits);
1214 macro_copyComplexMatrix(dest, src.cpuElems, dest.size());
1215 return dest;
1216}
1217
1219 DEMAND( qureg.isDensityMatrix );
1220#if COMPILE_MPI
1221 DEMAND( qureg.numAmps < MPI_MAX_AMPS_IN_MSG );
1222#endif
1223
1224 // ensure local qureg amps are up to date
1225 copyStateFromGPU(qureg);
1226 syncQuESTEnv();
1227
1228 // collect all amps between all nodes
1229 qcomp* allAmps = qureg.cpuAmps;
1230
1231 // in distributed mode, give every node the full state vector
1232#if COMPILE_MPI
1233 if (qureg.isDistributed) {
1234 allAmps = (qcomp*) malloc(qureg.numAmps * sizeof *allAmps);
1235 MPI_Allgather(
1236 qureg.cpuAmps, qureg.numAmpsPerNode, MPI_QCOMP,
1237 allAmps, qureg.numAmpsPerNode, MPI_QCOMP, MPI_COMM_WORLD);
1238 }
1239#endif
1240
1241 // copy full state vector into a QVector
1242 long long int dim = (1LL << qureg.numQubits);
1243 QMatrix matr = getZeroMatrix(dim);
1244 for (long long int n=0; n<qureg.numAmps; n++)
1245 matr[n%dim][n/dim] = allAmps[n];
1246
1247 // clean up if we malloc'd the distributed array
1248 if (qureg.isDistributed)
1249 free(allAmps);
1250 return matr;
1251}
1252
1254 DEMAND( !qureg.isDensityMatrix );
1255#if COMPILE_MPI
1256 DEMAND( qureg.numAmps < MPI_MAX_AMPS_IN_MSG );
1257#endif
1258
1259 // ensure local qureg amps are up to date
1260 copyStateFromGPU(qureg);
1261 syncQuESTEnv();
1262
1263 qcomp* allAmps = qureg.cpuAmps;
1264
1265 // in distributed mode, give every node the full state vector
1266#if COMPILE_MPI
1267 if (qureg.isDistributed) {
1268 allAmps = (qcomp*) malloc(qureg.numAmps * sizeof *allAmps);
1269
1270 MPI_Allgather(
1271 qureg.cpuAmps, qureg.numAmpsPerNode, MPI_QCOMP,
1272 allAmps, qureg.numAmpsPerNode, MPI_QCOMP, MPI_COMM_WORLD);
1273 }
1274#endif
1275
1276 // copy full state vector into a QVector
1277 QVector vec = QVector(qureg.numAmps);
1278 for (long long int i=0; i<qureg.numAmps; i++)
1279 vec[i] = allAmps[i];
1280
1281 // clean up if we malloc'd distrib array
1282 if (qureg.isDistributed)
1283 free(allAmps);
1284
1285 return vec;
1286}
1287
1289
1290 return vector<qcomp>(matr.cpuElems, matr.cpuElems + matr.numElems);
1291}
1292
1294
1295#if COMPILE_MPI
1296 DEMAND( matr.numElems < MPI_MAX_AMPS_IN_MSG );
1297#endif
1298
1299 vector<qcomp> vec(matr.numElems);
1300
1301 // in distributed mode, give every node the full diagonal operator
1302 if (matr.isDistributed) {
1303 #if COMPILE_MPI
1304 MPI_Allgather(
1305 matr.cpuElems, matr.numElemsPerNode, MPI_QCOMP,
1306 vec.data(), matr.numElemsPerNode, MPI_QCOMP, MPI_COMM_WORLD);
1307 #endif
1308 } else {
1309 vec.assign(matr.cpuElems, matr.cpuElems + matr.numElems);
1310 }
1311
1312 return vec;
1313}
1314
1316 QVector vec = toQVector(in);
1317 QMatrix mat = getZeroMatrix(in.numElems);
1318 for (size_t i=0; i<mat.size(); i++)
1319 mat[i][i] = vec[i];
1320 return mat;
1321}
1322
1324 QMatrix mat = getZeroMatrix(in.numElems);
1325 for (size_t i=0; i<mat.size(); i++)
1326 mat[i][i] = in.cpuElems[i];
1327 return mat;
1328}
1329
1330void toQureg(Qureg qureg, QVector vec) {
1331 DEMAND( !qureg.isDensityMatrix );
1332 DEMAND( qureg.numAmps == (long long int) vec.size() );
1333
1334 syncQuESTEnv();
1335
1336 for (int i=0; i<qureg.numAmpsPerNode; i++) {
1337 int ind = qureg.rank*qureg.numAmpsPerNode + i;
1338 qureg.cpuAmps[i] = vec[ind];
1339 }
1340 copyStateToGPU(qureg);
1341}
1342void toQureg(Qureg qureg, QMatrix mat) {
1343 DEMAND( qureg.isDensityMatrix );
1344 DEMAND( (1LL << qureg.numQubits) == (long long int) mat.size() );
1345
1346 syncQuESTEnv();
1347
1348 int len = (1 << qureg.numQubits);
1349 for (int i=0; i<qureg.numAmpsPerNode; i++) {
1350 int ind = qureg.rank*qureg.numAmpsPerNode + i;
1351 qureg.cpuAmps[i] = mat[ind%len][ind/len];
1352 }
1353 copyStateToGPU(qureg);
1354}
1355
1356PauliStr getRandomPauliStr(int numQubits) {
1357
1358 std::string paulis = "";
1359 for (int i=0; i<numQubits; i++)
1360 paulis += "IXYZ"[getRandomInt(0,4)];
1361
1362 return getPauliStr(paulis);
1363}
1364PauliStr getRandomDiagPauliStr(int numQubits) {
1365
1366 std::string paulis = "";
1367 for (int i=0; i<numQubits; i++)
1368 paulis += "IX"[getRandomInt(0,2)];
1369
1370 return getPauliStr(paulis);
1371}
1372
1373void setRandomPauliSum(qreal* coeffs, pauliOpType* codes, int numQubits, int numTerms) {
1374 int i=0;
1375 for (int n=0; n<numTerms; n++) {
1376 coeffs[n] = getRandomReal(-5, 5);
1377 for (int q=0; q<numQubits; q++)
1378 codes[i++] = (pauliOpType) getRandomInt(0,4);
1379 }
1380}
1381
1382void setRandomPauliSum(PauliHamil hamil, int numQubits) {
1383
1384 for (int n=0; n<hamil.numTerms; n++) {
1385 hamil.coeffs[n] = getRandomReal(-5, 5);
1386 hamil.strings[n] = getRandomPauliStr(numQubits);
1387 }
1388}
1389
1390void setRandomDiagPauliHamil(PauliHamil hamil, int numQubits) {
1391 for (int n=0; n<hamil.numTerms; n++) {
1392 hamil.coeffs[n] = getRandomReal(-5, 5);
1393 hamil.strings[n] = getRandomDiagPauliStr(numQubits);
1394 }
1395}
1396
1397void setRandomTargets(int* targs, int numTargs, int numQb) {
1398 DEMAND( numQb >= 1 );
1399 DEMAND( numTargs >= 1);
1400 DEMAND( numTargs <= numQb );
1401
1402 // create an ordered list of all possible qubits
1403 vector<int> allQb(numQb);
1404 for (int q=0; q<numQb; q++)
1405 allQb[q] = q;
1406
1407 // shuffle all qubits (must be consistent on each node)
1408 std::shuffle(&allQb[0], &allQb[numQb], randomGenerator);
1409
1410 // select numTargs of all qubits
1411 for (int i=0; i<numTargs; i++)
1412 targs[i] = allQb[i];
1413}
1414void setRandomTargets(vector<int> &targs, int numQb) {
1415
1416 setRandomTargets(targs.data(), targs.size(), numQb);
1417}
1418
1419QMatrix toQMatrix(qreal* coeffs, pauliOpType* paulis, int numQubits, int numTerms) {
1420
1421 // produce a numTargs-big matrix 'pauliSum' by pauli-matrix tensoring and summing
1422 QMatrix iMatr{{1,0},{0,1}};
1423 QMatrix xMatr{{0,1},{1,0}};
1424 QMatrix yMatr{{0,-qcomp(0,1)},{qcomp(0,1),0}};
1425 QMatrix zMatr{{1,0},{0,-1}};
1426 QMatrix pauliSum = getZeroMatrix(1<<numQubits);
1427
1428 for (int t=0; t<numTerms; t++) {
1429 QMatrix pauliProd = QMatrix{{1}};
1430
1431 for (int q=0; q<numQubits; q++) {
1432 int i = q + t*numQubits;
1433
1434 QMatrix fac;
1435 pauliOpType code = paulis[i];
1436 if (code == PAULI_I) fac = iMatr;
1437 if (code == PAULI_X) fac = xMatr;
1438 if (code == PAULI_Y) fac = yMatr;
1439 if (code == PAULI_Z) fac = zMatr;
1440 pauliProd = getKroneckerProduct(fac, pauliProd);
1441 }
1442 pauliSum += coeffs[t] * pauliProd;
1443 }
1444
1445 // a now 2^numQubits by 2^numQubits Hermitian matrix
1446 return pauliSum;
1447}
1448
1449// QMatrix toQMatrix(PauliHamil hamil) {
1450// return toQMatrix(hamil.termCoeffs, hamil.pauliCodes, hamil.numQubits, hamil.numSumTerms);
1451// }
1452
1453
1454long long int getTwosComplement(long long int decimal, int numBits) {
1455 DEMAND( decimal >= 0 );
1456 DEMAND( numBits >= 2 );
1457 DEMAND( decimal < (1LL << numBits) );
1458
1459 long long int maxMag = 1LL << (numBits-1);
1460 if (decimal >= maxMag)
1461 return -maxMag + (decimal - maxMag);
1462 else
1463 return decimal;
1464}
1465
1466long long int getUnsigned(long long int twosComp, int numBits) {
1467 DEMAND( numBits >= 2 );
1468 DEMAND( twosComp < (1LL << (numBits-1)) );
1469 DEMAND( twosComp >= - (1LL << (numBits-1)) );
1470
1471 if (twosComp >= 0)
1472 return twosComp;
1473 else
1474 return (1<<numBits) + twosComp;
1475}
1476
1478 QMatrix mat = getZeroMatrix(vec.size());
1479 for (size_t i=0; i<vec.size(); i++)
1480 mat[i][i] = vec[i];
1481 return mat;
1482}
1483
1484// void setDiagMatrixOverrides(QMatrix &matr, int* numQubitsPerReg, int numRegs, enum bitEncoding encoding, long long int* overrideInds, qreal* overridePhases, int numOverrides) {
1485// DEMAND( (encoding == UNSIGNED || encoding == TWOS_COMPLEMENT) );
1486// DEMAND( numRegs > 0 );
1487// DEMAND( numOverrides >= 0 );
1488
1489// int totalQb = 0;
1490// for (int r=0; r<numRegs; r++) {
1491// DEMAND( numQubitsPerReg[r] > 0 );
1492// totalQb += numQubitsPerReg[r];
1493// }
1494// DEMAND( matr.size() == (1 << totalQb) );
1495
1496// // record whether a diagonal index has been already overriden
1497// vector<int> hasBeenOverriden(1 << totalQb);
1498// for (int i=0; i<(1 << totalQb); i++)
1499// hasBeenOverriden[i] = 0;
1500
1501// int flatInd = 0;
1502// for (int v=0; v<numOverrides; v++) {
1503// int matrInd = 0;
1504// int numQubitsLeft = 0;
1505
1506// for (int r=0; r<numRegs; r++) {
1507
1508// if (encoding == UNSIGNED)
1509// matrInd += overrideInds[flatInd] * (1 << numQubitsLeft);
1510// else if (encoding == TWOS_COMPLEMENT)
1511// matrInd += getUnsigned(overrideInds[flatInd], numQubitsPerReg[r]) * (1 << numQubitsLeft);
1512
1513// numQubitsLeft += numQubitsPerReg[r];
1514// flatInd += 1;
1515// }
1516
1517// if (!hasBeenOverriden[matrInd]) {
1518// matr[matrInd][matrInd] = expI(overridePhases[v]);
1519// hasBeenOverriden[matrInd] = 1;
1520// }
1521// }
1522// }
1523
1524static int fn_unique_suffix_id = 0;
1525
1526void setUniqueFilename(char* outFn, int maxlen, char* prefix) {
1527 snprintf(outFn, maxlen, "%s_%d.txt", prefix, fn_unique_suffix_id++);
1528}
1529
1530void writeToFileSynch(char* fn, const string& contents) {
1531
1532 // master node writes
1533 if (getQuESTEnv().rank == 0) {
1534 FILE* file = fopen(fn, "w");
1535 fputs(contents.c_str(), file);
1536 fclose(file);
1537 }
1538
1539 // other nodes wait
1540 syncQuESTEnv();
1541}
1542
1543void deleteFilesWithPrefixSynch(char* prefix) {
1544
1545 // master node deletes all files
1546 if (getQuESTEnv().rank == 0) {
1547 char cmd[200];
1548 snprintf(cmd, 200, "exec rm %s*", prefix);
1549 system(cmd);
1550 }
1551
1552 // other nodes wait
1553 syncQuESTEnv();
1554}
1555
1556/// @private
1557class SubListGenerator : public Catch::Generators::IGenerator<int*> {
1558 int* list;
1559 int* sublist;
1560 int len;
1561 int sublen;
1562 vector<bool> featured;
1563private:
1564 void createSublist() {
1565
1566 // sublist to send to the user
1567 sublist = (int*) malloc(sublen * sizeof *sublist);
1568
1569 // indicates which list members are currently in sublist
1570 featured = vector<bool>(len);
1571 fill(featured.end() - sublen, featured.end(), true);
1572 }
1573
1574 void prepareSublist() {
1575
1576 // choose the next combination
1577 int j=0;
1578 for (int i=0; i<len; i++)
1579 if (featured[i])
1580 sublist[j++] = list[i];
1581
1582 // prepare for permuting
1583 std::sort(sublist, sublist+sublen);
1584 }
1585public:
1586 SubListGenerator(int* elems, int numElems, int numSamps) {
1587
1588 DEMAND( numSamps <= numElems );
1589
1590 // make a record of all elements
1591 len = numElems;
1592 list = (int*) malloc(len * sizeof *list);
1593 for (int i=0; i<len; i++)
1594 list[i] = elems[i];
1595
1596 // prepare sublist
1597 sublen = numSamps;
1598 createSublist();
1599 prepareSublist();
1600 }
1601
1602 SubListGenerator(
1603 Catch::Generators::GeneratorWrapper<int>&& gen,
1604 int numSamps, const int* exclude, int numExclude
1605 ) {
1606 // extract all generator elems
1607 vector<int> elems = vector<int>();
1608 do { elems.push_back(gen.get()); } while (gen.next());
1609
1610 // make (int*) of non-excluded elems
1611 len = 0;
1612 list = (int*) malloc(elems.size() * sizeof *list);
1613 for (size_t i=0; i<elems.size(); i++) {
1614 int elem = elems[i];
1615 bool present = false;
1616 for (int j=0; j<numExclude; j++)
1617 if (elem == exclude[j]) {
1618 present = true;
1619 break;
1620 }
1621 if (!present)
1622 list[len++] = elem;
1623 }
1624
1625 DEMAND( numSamps <= len );
1626
1627 // prepare sublist
1628 sublen = numSamps;
1629 createSublist();
1630 prepareSublist();
1631 }
1632
1633 int* const& get() const override {
1634 return sublist;
1635 }
1636
1637 bool next() override {
1638
1639 // offer next permutation of the current combination
1640 if (std::next_permutation(sublist, sublist+sublen))
1641 return true;
1642
1643 // else generate the next combination
1644 if (std::next_permutation(featured.begin(), featured.end())) {
1645 prepareSublist();
1646 return true;
1647 }
1648
1649 return false;
1650 }
1651
1652 ~SubListGenerator() {
1653 free(list);
1654 free(sublist);
1655 }
1656};
1657Catch::Generators::GeneratorWrapper<int*> sublists(
1658 int* list, int len, int sublen
1659) {
1660 return Catch::Generators::GeneratorWrapper<int*>(
1661 Catch::Detail::make_unique<SubListGenerator>(list, len, sublen));
1662}
1663Catch::Generators::GeneratorWrapper<int*> sublists(
1664 Catch::Generators::GeneratorWrapper<int>&& gen, int numSamps, const int* exclude, int numExclude
1665) {
1666 return Catch::Generators::GeneratorWrapper<int*>(
1667 Catch::Detail::make_unique<SubListGenerator>(std::move(gen), numSamps, exclude, numExclude));
1668}
1669Catch::Generators::GeneratorWrapper<int*> sublists(
1670 Catch::Generators::GeneratorWrapper<int>&& gen, int numSamps, int excluded
1671) {
1672 int exclude[] = {excluded};
1673 return Catch::Generators::GeneratorWrapper<int*>(
1674 Catch::Detail::make_unique<SubListGenerator>(std::move(gen), numSamps, exclude, 1));
1675}
1676Catch::Generators::GeneratorWrapper<int*> sublists(
1677 Catch::Generators::GeneratorWrapper<int>&& gen, int numSamps
1678) {
1679 int exclude[] = {-1}; // non-empty to satisfy MSVC
1680 return Catch::Generators::GeneratorWrapper<int*>(
1681 Catch::Detail::make_unique<SubListGenerator>(std::move(gen), numSamps, exclude, 0));
1682}
1683
1684/// @private
1685template <typename T>
1686class SequenceGenerator : public Catch::Generators::IGenerator<T*> {
1687 T* digits;
1688 int len;
1689 T maxDigit;
1690 int ind;
1691 int seqLen;
1692public:
1693 SequenceGenerator(T maxDigit_, int numDigits) {
1694 ind = 0;
1695 len = numDigits;
1696 maxDigit = maxDigit_;
1697 seqLen = (int) pow(1 + (int) maxDigit, len);
1698 digits = (T*) malloc(numDigits * sizeof *digits);
1699 for (int i=0; i<numDigits; i++)
1700 digits[i] = (T) 0;
1701 ind++;
1702 }
1703
1704 T* const& get() const override {
1705 return digits;
1706 }
1707
1708 bool next() override {
1709 bool isNext = (ind++) < seqLen;
1710 if (isNext) {
1711 int i=0;
1712 while (digits[i] == maxDigit)
1713 digits[i++] = (T) 0;
1714 digits[i] = (T) ((int) digits[i] + 1);
1715 }
1716 return isNext;
1717 }
1718
1719 ~SequenceGenerator() {
1720 free(digits);
1721 }
1722};
1723Catch::Generators::GeneratorWrapper<int*> bitsets(int numBits) {
1724 return Catch::Generators::GeneratorWrapper<int*>(
1725 Catch::Detail::make_unique<SequenceGenerator<int>>(1, numBits));
1726}
1727Catch::Generators::GeneratorWrapper<int*> sequences(int base, int numDigits) {
1728 return Catch::Generators::GeneratorWrapper<int*>(
1729 Catch::Detail::make_unique<SequenceGenerator<int>>(base-1, numDigits));
1730}
1731Catch::Generators::GeneratorWrapper<pauliOpType*> pauliseqs(int numPaulis) {
1732 return Catch::Generators::GeneratorWrapper<pauliOpType*>(
1733 Catch::Detail::make_unique<SequenceGenerator<pauliOpType>>(PAULI_Z, numPaulis));
1734}
void applyReferenceMatrix(QVector &state, int *ctrls, int numCtrls, int *targs, int numTargs, QMatrix op)
void setRandomPauliSum(qreal *coeffs, pauliOpType *codes, int numQubits, int numTerms)
void setUniqueFilename(char *outFn, int maxlen, char *prefix)
Catch::Generators::GeneratorWrapper< int * > sequences(int base, int numDigits)
QMatrix getFullOperatorMatrix(int *ctrls, int numCtrls, int *targs, int numTargs, QMatrix op, int numQubits)
ComplexMatrix4 toComplexMatrix4(QMatrix qm)
unsigned int calcLog2(long unsigned int res)
QVector getRandomQVector(int dim)
QMatrix getKetBra(QVector ket, QVector bra)
Catch::Generators::GeneratorWrapper< int * > sublists(int *list, int len, int sublen)
QMatrix getSwapMatrix(int qb1, int qb2, int numQb)
QMatrix getMixedDensityMatrix(vector< qreal > probs, vector< QVector > states)
bool areEqual(QVector a, QVector b)
long long int getTwosComplement(long long int decimal, int numBits)
long long int getValueOfTargets(long long int ind, int *targs, int numTargs)
QVector getNormalised(QVector vec)
void assertQuregAndRefInDebugState(Qureg qureg, QVector ref)
vector< vector< qcomp > > QMatrix
ComplexMatrix2 toComplexMatrix2(QMatrix qm)
void applyReferenceOp(QVector &state, int *ctrls, int numCtrls, int *targs, int numTargs, QMatrix op)
Catch::Generators::GeneratorWrapper< pauliOpType * > pauliseqs(int numPaulis)
QVector getDFT(QVector in)
void toComplexMatrixN(QMatrix qm, ComplexMatrixN cm)
vector< QVector > getRandomOrthonormalVectors(int numQb, int numStates)
QVector getMatrixDiagonal(QMatrix matr)
void setRandomDiagPauliHamil(PauliHamil hamil, int numQubits)
void writeToFileSynch(char *fn, const string &contents)
QMatrix getRandomQMatrix(int dim)
void setRandomTargets(int *targs, int numTargs, int numQb)
QMatrix toDiagonalQMatrix(QVector vec)
QMatrix toQMatrix(CompMatr1 src)
QVector getKroneckerProduct(QVector b, QVector a)
vector< qcomp > QVector
void deleteFilesWithPrefixSynch(char *prefix)
QVector toQVector(Qureg qureg)
QMatrix getPureDensityMatrix(QVector state)
long long int getUnsigned(long long int twosComp, int numBits)
Catch::Generators::GeneratorWrapper< int * > bitsets(int numBits)
void toQureg(Qureg qureg, QVector vec)
QuESTEnv getQuESTEnv()
void syncQuESTEnv()
void syncCompMatr(CompMatr matr)
Definition matrices.cpp:377
PauliStr getPauliStr(const char *paulis, int *indices, int numPaulis)
Definition paulis.cpp:296
QMatrix getConjugateTranspose(QMatrix a)
QMatrix getExponentialOfDiagonalMatrix(QMatrix a)
QMatrix getExponentialOfPauliMatrix(qreal angle, QMatrix a)
QMatrix getIdentityMatrix(size_t dim)
void setSubMatrix(QMatrix &dest, QMatrix sub, size_t r, size_t c)
QMatrix getZeroMatrix(size_t dim)
QVector getRandomStateVector(int numQb)
qcomp getRandomComplex()
QMatrix getRandomPureDensityMatrix(int numQb)
QMatrix getRandomUnitary(int numQb)
void setRandomTestStateSeeds()
QMatrix getRandomDensityMatrix(int numQb)
qreal getRandomReal(qreal min, qreal max)
vector< qreal > getRandomProbabilities(int numProbs)
vector< QMatrix > getRandomKrausMap(int numQb, int numOps)
int getRandomInt(int min, int max)
Definition qureg.h:42