Sequential Quantum Gate Decomposer  v1.9.3
Powerful decomposition of general unitarias into one- and two-qubit gates gates
List of all members | Public Member Functions | Static Public Member Functions | Public Attributes | Static Public Attributes | Protected Member Functions | Protected Attributes
Optimization_Interface Class Reference

A base class to determine the decomposition of an N-qubit unitary into a sequence of CNOT and U3 gates. More...

#include <Optimization_Interface.h>

Inheritance diagram for Optimization_Interface:
Inheritance graph
[legend]

Public Member Functions

void add_adaptive (int target_qbit, int control_qbit)
 Append a Adaptive gate to the list of gates. More...
 
void add_adaptive_to_front (int target_qbit, int control_qbit)
 Add a Adaptive gate to the front of the list of gates. More...
 
void add_ch (int target_qbit, int control_qbit)
 Append a CH gate (i.e. More...
 
void add_ch_to_front (int target_qbit, int control_qbit)
 Add a CH gate (i.e. More...
 
void add_child (Gate *child)
 Call to add a child gate to the current gate. More...
 
void add_cnot (int target_qbit, int control_qbit)
 Append a CNOT gate gate to the list of gates. More...
 
void add_cnot_to_front (int target_qbit, int control_qbit)
 Add a C_NOT gate gate to the front of the list of gates. More...
 
void add_composite ()
 Append a Composite gate to the list of gates. More...
 
void add_composite_to_front ()
 Add a Composite gate to the front of the list of gates. More...
 
void add_crot (int target_qbit, int control_qbit, crot_type subtype_in)
 Append a CNOT gate gate to the list of gates. More...
 
void add_crot_to_front (int target_qbit, int control_qbit, crot_type subtype_in)
 Add a C_NOT gate gate to the front of the list of gates. More...
 
void add_cry (int target_qbit, int control_qbit)
 Append a CRY gate to the list of gates. More...
 
void add_cry_to_front (int target_qbit, int control_qbit)
 Add a CRY gate to the front of the list of gates. More...
 
void add_cz (int target_qbit, int control_qbit)
 Append a CZ gate gate to the list of gates. More...
 
void add_cz_nu (int target_qbit, int control_qbit)
 Append a CZ_NU gate to the list of gates. More...
 
void add_cz_nu_to_front (int target_qbit, int control_qbit)
 Add a CZ_NU gate to the front of the list of gates. More...
 
void add_cz_to_front (int target_qbit, int control_qbit)
 Add a CZ gate gate to the front of the list of gates. More...
 
virtual void add_finalyzing_layer ()
 Call to add further layer to the gate structure used in the subdecomposition. More...
 
void add_gate (Gate *gate)
 Append a general gate to the list of gates. More...
 
void add_gate_nums (std::map< std::string, int > &gate_nums)
 Call to add the number of the individual gate types in the circuit to the map given in the argument. More...
 
void add_gate_to_front (Gate *gate)
 Add an gate to the front of the list of gates. More...
 
void add_gates (std::vector< Gate *> gates_in)
 Append a list of gates to the list of gates. More...
 
void add_gates_to_front (std::vector< Gate *> gates_in)
 Add an array of gates to the front of the list of gates. More...
 
void add_h (int target_qbit)
 Append a Hadamard gate to the list of gates. More...
 
void add_h_to_front (int target_qbit)
 Add a Hadamard gate to the front of the list of gates. More...
 
void add_on ()
 Append a ON gate to the list of gates. More...
 
void add_on_to_front ()
 Add a OUN gate to the front of the list of gates. More...
 
void add_parent (Gate *parent)
 Call to add a parent gate to the current gate. More...
 
void add_r (int target_qbit)
 Append a R gate to the list of gates. More...
 
void add_r_to_front (int target_qbit)
 Add a R gate to the front of the list of gates. More...
 
void add_rx (int target_qbit)
 Append a RX gate to the list of gates. More...
 
void add_rx_to_front (int target_qbit)
 Add a RX gate to the front of the list of gates. More...
 
void add_ry (int target_qbit)
 Append a RY gate to the list of gates. More...
 
void add_ry_to_front (int target_qbit)
 Add a RY gate to the front of the list of gates. More...
 
void add_rz (int target_qbit)
 Append a RZ gate to the list of gates. More...
 
void add_rz_to_front (int target_qbit)
 Add a RZ gate to the front of the list of gates. More...
 
void add_sx (int target_qbit)
 Append a SX gate to the list of gates. More...
 
void add_sx_to_front (int target_qbit)
 Add a SX gate to the front of the list of gates. More...
 
void add_syc (int target_qbit, int control_qbit)
 Append a Sycamore gate (i.e. More...
 
void add_syc_to_front (int target_qbit, int control_qbit)
 Add a Sycamore gate (i.e. More...
 
void add_t (int target_qbit)
 Append a T gate to the list of gates. More...
 
void add_t_to_front (int target_qbit)
 Add a T gate to the front of the list of gates. More...
 
void add_tdg (int target_qbit)
 Append a Tdg gate to the list of gates. More...
 
void add_tdg_to_front (int target_qbit)
 Add a Tdg gate to the front of the list of gates. More...
 
void add_u1 (int target_qbit)
 Append a U1 gate to the list of gates. More...
 
void add_u1_to_front (int target_qbit)
 Add a U1 gate to the front of the list of gates. More...
 
void add_u2 (int target_qbit)
 Append a U2 gate to the list of gates. More...
 
void add_u2_to_front (int target_qbit)
 Add a U2 gate to the front of the list of gates. More...
 
void add_u3 (int target_qbit)
 Append a U3 gate to the list of gates. More...
 
void add_u3_to_front (int target_qbit)
 Add a U3 gate to the front of the list of gates. More...
 
void add_un ()
 Append a UN gate to the list of gates. More...
 
void add_un_to_front ()
 Add a UN gate to the front of the list of gates. More...
 
void add_x (int target_qbit)
 Append a X gate to the list of gates. More...
 
void add_x_to_front (int target_qbit)
 Add a X gate to the front of the list of gates. More...
 
void add_y (int target_qbit)
 Append a Y gate to the list of gates. More...
 
void add_y_to_front (int target_qbit)
 Add a Y gate to the front of the list of gates. More...
 
void add_z (int target_qbit)
 Append a Z gate to the list of gates. More...
 
void add_z_to_front (int target_qbit)
 Add a Z gate to the front of the list of gates. More...
 
virtual std::vector< Matrixapply_derivate_to (Matrix_real &parameters_mtx, Matrix &input, int parallel)
 Call to evaluate the derivate of the circuit on an inout with respect to all of the free parameters. More...
 
virtual void apply_from_right (Matrix_real &parameters_mtx, Matrix &input)
 Call to apply the gate on the input array/matrix by input*CNOT. More...
 
virtual void apply_from_right (Matrix &input)
 Call to apply the gate on the input array/matrix by input*Gate. More...
 
Matrix apply_gate (Matrix &gate_mtx, Matrix &input_matrix)
 Apply an gates on the input matrix. More...
 
void apply_global_phase_factor (QGD_Complex16 global_phase_factor, Matrix &u3_gate)
 Call to apply the global phase to a matrix. More...
 
void apply_global_phase_factor ()
 Call to apply the current global phase to the unitary matrix. More...
 
virtual void apply_to (Matrix_real &parameters_mtx, Matrix &input, int parallel=0)
 Call to apply the gate on the input array/matrix Gates_block*input. More...
 
virtual void apply_to (Matrix &input, int parallel)
 Call to apply the gate on the input array/matrix. More...
 
void apply_to_list (Matrix_real &parameters, std::vector< Matrix > &inputs, int parallel)
 Call to apply the gate on the input array/matrix by U3*input. More...
 
virtual void apply_to_list (std::vector< Matrix > &inputs, int parallel)
 Call to apply the gate on a list of inputs. More...
 
void calc_decomposition_error (Matrix &decomposed_matrix)
 Calculate the error of the decomposition according to the spectral norm of \( U-U_{approx} \), where \( U_{approx} \) is the unitary produced by the decomposing quantum cirquit. More...
 
virtual Matrix calc_one_qubit_u3 (double Theta, double Phi, double Lambda)
 Calculate the matrix of a U3 gate gate corresponding to the given parameters acting on a single qbit space. More...
 
virtual Matrix calc_one_qubit_u3 ()
 Calculate the matrix of the constans gates. More...
 
void calculate_new_global_phase_factor (QGD_Complex16 global_phase_factor_new)
 Calculate the new global phase of the Unitary matrix after removing a trivial U3 matrix. More...
 
bool check_optimization_solution ()
 check_optimization_solution More...
 
void clear_children ()
 Call to erase data on children. More...
 
void clear_parents ()
 Call to erase data on parents. More...
 
virtual Gates_blockclone ()
 Create a clone of the present class. More...
 
void combine (Gates_block *op_block)
 Call to append the gates of an gate block to the current block. More...
 
bool contains_adaptive_gate ()
 Call to determine, whether the circuit contains daptive gate or not. More...
 
bool contains_adaptive_gate (int idx)
 Call to determine, whether the sub-circuit at a given position in the circuit contains daptive gate or not. More...
 
Gates_blockcreate_remapped_circuit (const std::map< int, int > &qbit_map)
 Call to create a new circuit with remapped qubits. More...
 
Gates_blockcreate_remapped_circuit (const std::map< int, int > &qbit_map, const int qbit_num_)
 Call to create a new circuit with remapped qubits. More...
 
void determine_children (Gate *gate)
 Call to obtain the child gates in the circuit. More...
 
void determine_parents (Gate *gate)
 Call to obtain the parent gates in the circuit. More...
 
void export_current_cost_fnc (double current_minimum)
 Call to print out into a file the current cost function and the second Rényi entropy on the subsystem made of qubits 0 and 1. More...
 
void export_current_cost_fnc (double current_minimum, Matrix_real &parameters)
 Call to print out into a file the current cost function and the second Rényi entropy on the subsystem made of qubits 0 and 1. More...
 
void export_unitary (std::string &filename)
 exports unitary matrix to binary file More...
 
int extract_gates (Gates_block *op_block)
 Call to extract the gates stored in the class. More...
 
virtual Matrix_real extract_parameters (Matrix_real &parameters)
 Call to extract parameters from the parameter array corresponding to the circuit, in which the gate is embedded. More...
 
void final_optimization ()
 final optimization procedure improving the accuracy of the decompositin when all the qubits were already disentangled. More...
 
void fragment_circuit ()
 
int get_accelerator_num ()
 Get the number of accelerators to be reserved on DFEs on users demand. More...
 
std::vector< Gate * > get_children ()
 Call to get the children of the current gate. More...
 
int get_control_qbit ()
 Call to get the index of the control qubit. More...
 
double get_correction1_scale ()
 Call to get the prefactor of the single-bitflip errors in the cost function. More...
 
double get_correction2_scale ()
 Call to get the prefactor of the two-bitflip errors in the cost function. More...
 
cost_function_type get_cost_function_variant ()
 Call to get the variant of the cost function used in the calculations. More...
 
double get_current_minimum ()
 Call to get the obtained minimum of the cost function. More...
 
Matrix get_decomposed_matrix ()
 Calculate the decomposed matrix resulted by the effect of the optimized gates on the unitary Umtx. More...
 
double get_decomposition_error ()
 Call to get the error of the decomposition. More...
 
Gates_blockget_flat_circuit ()
 Method to generate a flat circuit. More...
 
Gateget_gate (int idx)
 Call to get the gates stored in the class. More...
 
int get_gate_num ()
 Call to get the number of gates grouped in the class. More...
 
std::map< std::string, intget_gate_nums ()
 Call to get the number of the individual gate types in the list of gates. More...
 
std::vector< Gate * > get_gates ()
 Call to get the gates stored in the class. More...
 
QGD_Complex16 get_global_phase_factor ()
 Get the global phase of the Unitary matrix. More...
 
std::vector< intget_involved_qubits ()
 Call to get the qubits involved in the gates stored in the block of gates. More...
 
Matrix get_matrix (Matrix_real &parameters)
 Call to retrieve the gate matrix (Which is the product of all the gate matrices stored in the gate block) More...
 
Matrix get_matrix (Matrix_real &parameters, int parallel)
 Call to retrieve the gate matrix (Which is the product of all the gate matrices stored in the gate block) More...
 
virtual Matrix get_matrix ()
 Call to retrieve the operation matrix. More...
 
virtual Matrix get_matrix (int parallel)
 Call to retrieve the operation matrix. More...
 
std::string get_name ()
 Call to get the name label of the gate. More...
 
int get_num_iters ()
 Get the number of processed iterations during the optimization process. More...
 
Matrix_real get_optimized_parameters ()
 Call to get the optimized parameters. More...
 
void get_optimized_parameters (double *ret)
 Call to get the optimized parameters. More...
 
int get_parallel_configuration ()
 Get the parallel configuration from the config. More...
 
void get_parameter_max (Matrix_real &range_max)
 
int get_parameter_num ()
 Call to get the number of free parameters. More...
 
int get_parameter_start_idx ()
 Call to get the starting index of the parameters in the parameter array corresponding to the circuit in which the current gate is incorporated. More...
 
std::vector< Gate * > get_parents ()
 Call to get the parents of the current gate. More...
 
double get_previous_cost_function_value ()
 Call to retrieve the previous value of the cost funtion to be used to evaluate bitflip errors in the cost funtion (see Eq. More...
 
std::string get_project_name ()
 Call to get the current name of the project. More...
 
int get_qbit_num ()
 Call to get the number of qubits composing the unitary. More...
 
Matrix get_reduced_density_matrix (Matrix_real &parameters_mtx, Matrix &input_state, matrix_base< int > &qbit_list_subset)
 Call to evaluate the reduced densiy matrix. More...
 
double get_second_Renyi_entropy (Matrix_real &parameters_mtx, Matrix &input_state, matrix_base< int > &qbit_list)
 Call to evaluate the seconf Rényi entropy. More...
 
int get_target_qbit ()
 Call to get the index of the target qubit. More...
 
int get_trace_offset ()
 Get the trace ffset used in the evaluation of the cost function. More...
 
gate_type get_type ()
 Call to get the type of the operation. More...
 
Matrix get_Umtx ()
 Call to retrive a pointer to the unitary to be transformed. More...
 
int get_Umtx_size ()
 Call to get the size of the unitary to be transformed. More...
 
Matrix import_unitary_from_binary (std::string &filename)
 Import a Unitary matrix from a file. More...
 
void insert_gate (Gate *gate, int idx)
 Call to insert a gate at a given position. More...
 
void list_gates (int start_index)
 Call to print the gates decomposing the initial unitary. More...
 
void list_gates (const Matrix_real &parameters, int start_index)
 Call to print the list of gates stored in the block of gates for a specific set of parameters. More...
 
 Optimization_Interface ()
 Nullary constructor of the class. More...
 
 Optimization_Interface (Matrix Umtx_in, int qbit_num_in, bool optimize_layer_num_in, std::map< std::string, Config_Element > &config, guess_type initial_guess_in, int accelerator_num_in=0)
 Constructor of the class. More...
 
virtual double optimization_problem (const double *parameters)
 This is an abstact definition of function giving the cost functions measuring the entaglement of the qubits. More...
 
double optimization_problem (double *parameters)
 Evaluate the optimization problem of the optimization. More...
 
virtual double optimization_problem (Matrix_real &parameters)
 The optimization problem of the final optimization. More...
 
double optimization_problem (Matrix_real parameters, void *void_instance, Matrix ret_temp)
 The optimization problem of the final optimization. More...
 
Matrix_real optimization_problem_batched (std::vector< Matrix_real > &parameters_vec)
 The cost function of the optimization with batched input (implemented only for the Frobenius norm cost function when run with DFE) More...
 
virtual void optimization_problem_combined (Matrix_real parameters, double *f0, Matrix_real grad)
 Call to calculate both the cost function and the its gradient components. More...
 
virtual void optimization_problem_combined_non_static (Matrix_real parameters, void *void_instance, double *f0, Matrix_real &grad)
 Call to calculate both the cost function and the its gradient components. More...
 
void optimization_problem_combined_unitary (Matrix_real parameters, Matrix &Umtx, std::vector< Matrix > &Umtx_deriv)
 Call to calculate both the effect of the circuit on th eunitary and it's gradient componets. More...
 
virtual double optimization_problem_non_static (Matrix_real parameters, void *void_instance)
 The optimization problem of the final optimization. More...
 
double optimization_problem_panelty (double *parameters, Gates_block *gates_block)
 The optimization problem of the final optimization. More...
 
virtual void parameters_for_calc_one_qubit (double &ThetaOver2, double &Phi, double &Lambda)
 Calculate the matrix of a U3 gate gate corresponding to the given parameters acting on a single qbit space. More...
 
void print (const std::stringstream &sstream, int verbose_level=1) const
 Call to print output messages in the function of the verbosity level. More...
 
void randomize_parameters (Matrix_real &input, Matrix_real &output, const double &f0)
 Call to randomize the parameter. More...
 
void release_gate (int idx)
 Call to release one gate in the list. More...
 
void release_gates ()
 Call to release the stored gates. More...
 
void reorder_qubits (std::vector< int > qbit_list)
 Call to reorder the qubits in the matrix of the gate. More...
 
void reset_dependency_graph ()
 Method to reset the dependency graph of the gates in the circuit. More...
 
void reset_parameter_start_indices ()
 Method to reset the parameter start indices of gate operations incorporated in the circuit. More...
 
void set_children (std::vector< Gate *> &children_)
 Call to set the children of the current gate. More...
 
void set_control_qbit (int control_qbit_in)
 Call to set the control qubit for the gate operation. More...
 
void set_convergence_threshold (double convergence_threshold_in)
 Call to set the threshold of convergence in the optimization processes. More...
 
void set_cost_function_variant (cost_function_type variant)
 Call to set the variant of the cost function used in the calculations. More...
 
void set_custom_gate_structure (Gates_block *gate_structure_in)
 Call to set custom layers to the gate structure that are intended to be used in the subdecomposition. More...
 
void set_debugfile (std::string debugfile)
 Call to set the debugfile name. More...
 
void set_global_phase (double new_global_phase)
 Call to set global phase. More...
 
int set_iteration_loops (int n, int iteration_loops_in)
 Set the number of iteration loops during the subdecomposition of the n-th qubit. More...
 
int set_iteration_loops (std::map< int, int > iteration_loops_in)
 Set the number of iteration loops during the subdecomposition of the qbit-th qubit. More...
 
void set_matrix (Matrix input)
 Call to set the stored matrix in the operation. More...
 
void set_max_inner_iterations (int max_inner_iterations_in)
 Call to set the maximal number of iterations for which an optimization engine tries to solve the optimization problem. More...
 
void set_max_iteration (int max_outer_iterations_in)
 Call to set the maximal number of the iterations in the optimization process. More...
 
int set_max_layer_num (int n, int max_layer_num_in)
 Set the maximal number of layers used in the subdecomposition of the n-th qubit. More...
 
int set_max_layer_num (std::map< int, int > max_layer_num_in)
 Set the maximal number of layers used in the subdecomposition of the n-th qubit. More...
 
void set_optimization_blocks (int optimization_block_in)
 Call to set the number of gate blocks to be optimized in one shot. More...
 
void set_optimization_tolerance (double tolerance_in)
 Call to set the tolerance of the optimization processes. More...
 
void set_optimized_parameters (double *parameters, int num_of_parameters)
 Call to set the optimized parameters for initial optimization. More...
 
void set_optimizer (optimization_aglorithms alg_in)
 Call to set the optimizer engine to be used in solving the optimization problem. More...
 
void set_parameter_start_idx (int start_idx)
 Call to set the starting index of the parameters in the parameter array corresponding to the circuit in which the current gate is incorporated. More...
 
void set_parents (std::vector< Gate *> &parents_)
 Call to set the parents of the current gate. More...
 
void set_project_name (std::string &project_name_new)
 Call to set the name of the project. More...
 
void set_qbit_num (int qbit_num_in)
 Set the number of qubits spanning the matrix of the gates stored in the block of gates. More...
 
void set_random_shift_count_max (int random_shift_count_max_in)
 Call to set the maximal number of parameter randomization tries to escape a local minimum. More...
 
void set_target_qbit (int target_qbit_in)
 Call to set the target qubit for the gate operation. More...
 
void set_trace_offset (int trace_offset_in)
 Set the trace offset used in the evaluation of the cost function. More...
 
void set_verbose (int verbose_in)
 Call to set the verbose attribute. More...
 
void solve_layer_optimization_problem (int num_of_parameters, Matrix_real solution_guess)
 Call to solve layer by layer the optimization problem via calling one of the implemented algorithms. More...
 
void solve_layer_optimization_problem_ADAM (int num_of_parameters, Matrix_real &solution_guess)
 Call to solve layer by layer the optimization problem via ADAM algorithm. More...
 
void solve_layer_optimization_problem_ADAM_BATCHED (int num_of_parameters, Matrix_real &solution_guess_)
 Call to solve layer by layer the optimization problem via batched ADAM algorithm. More...
 
void solve_layer_optimization_problem_AGENTS (int num_of_parameters, Matrix_real &solution_guess)
 Call to solve layer by layer the optimization problem via the AGENT algorithm. More...
 
void solve_layer_optimization_problem_AGENTS_COMBINED (int num_of_parameters, Matrix_real &solution_guess)
 Call to solve layer by layer the optimization problem via the AGENT COMBINED algorithm. More...
 
void solve_layer_optimization_problem_BAYES_AGENTS (int num_of_parameters, Matrix_real &solution_guess)
 Call to solve layer by layer the optimization problem via Bayes & Agents algorithm. More...
 
void solve_layer_optimization_problem_BAYES_OPT (int num_of_parameters, Matrix_real &solution_guess)
 Call to solve layer by layer the optimization problem via Bayes algorithm. More...
 
void solve_layer_optimization_problem_BFGS (int num_of_parameters, Matrix_real &solution_guess)
 Call to solve layer by layer the optimization problem via BBFG algorithm. More...
 
void solve_layer_optimization_problem_BFGS2 (int num_of_parameters, Matrix_real solution_guess)
 Call to solve layer by layer the optimization problem via BBFG algorithm. More...
 
void solve_layer_optimization_problem_COSINE (int num_of_parameters, Matrix_real &solution_guess)
 Call to solve layer by layer the optimization problem via the COSINE algorithm. More...
 
void solve_layer_optimization_problem_GRAD_DESCEND (int num_of_parameters, Matrix_real &solution_guess)
 Call to solve layer by layer the optimization problem via the GRAD_DESCEND (line search in the direction determined by the gradient) algorithm. More...
 
void solve_layer_optimization_problem_GRAD_DESCEND_PARAMETER_SHIFT_RULE (int num_of_parameters, Matrix_real &solution_guess)
 Call to solve layer by layer the optimization problem via the GRAD_DESCEND_PARAMETER_SHIFT_RULE algorithm. More...
 
void solve_optimization_problem (double *solution_guess, int solution_guess_num)
 This method can be used to solve the main optimization problem which is devidid into sub-layer optimization processes. More...
 
virtual ~Optimization_Interface ()
 Destructor of the class. More...
 

Static Public Member Functions

static void export_current_cost_fnc (double current_minimum, Matrix_real &parameters, void *void_instance)
 Call to print out into a file the current cost function and the second Rényi entropy on the subsystem made of qubits 0 and 1. More...
 
static void Init_max_layer_num ()
 Initializes default layer numbers. More...
 
static double optimization_problem (Matrix_real parameters, void *void_instance)
 The optimization problem of the final optimization. More...
 
static void optimization_problem_combined (Matrix_real parameters, void *void_instance, double *f0, Matrix_real &grad)
 Call to calculate both the cost function and the its gradient components. More...
 
static void optimization_problem_combined_unitary (Matrix_real parameters, void *void_instance, Matrix &Umtx, std::vector< Matrix > &Umtx_deriv)
 Call to calculate both the effect of the circuit on th eunitary and it's gradient componets. More...
 
static void optimization_problem_grad (Matrix_real parameters, void *void_instance, Matrix_real &grad)
 Calculate the derivative of the cost function with respect to the free parameters. More...
 

Public Attributes

std::map< std::string, Config_Elementconfig
 config metadata utilized during the optimization More...
 
bool debug
 Logical variable. Set true to write output messages to the 'debug.txt' file. More...
 
std::string debugfile_name
 String variable. Set the debug file name. More...
 
QGD_Complex16 global_phase_factor
 The global phase. More...
 
int id
 unique id indentifying the instance of the class More...
 
int max_inner_iterations
 the maximal number of iterations for which an optimization engine tries to solve the optimization problem More...
 
int optimization_block
 number of gate blocks used in one shot of the optimization process More...
 
double optimization_tolerance
 The maximal allowed error of the optimization problem (The error of the decomposition would scale with the square root of this value) More...
 
std::string project_name
 the name of the project More...
 
int random_shift_count_max
 the maximal number of parameter randomization tries to escape a local minimum. More...
 
int verbose
 Set the verbosity level of the output messages. More...
 

Static Public Attributes

static std::map< int, intmax_layer_num_def
 A map of <int n: int num> indicating that how many layers should be used in the subdecomposition process by default for the subdecomposing of the nth qubits. More...
 

Protected Member Functions

void apply_kernel_from_right (Matrix &u3_1qbit, Matrix &input)
 Call to apply the gate kernel on the input state or unitary from right (no AVX support) More...
 
void apply_kernel_to (Matrix &u3_1qbit, Matrix &input, bool deriv=false, int parallel=0)
 Call to apply the gate kernel on the input state or unitary with optional AVX support. More...
 

Protected Attributes

int accelerator_num
 number of utilized accelerators More...
 
bool adaptive_eta
 logical variable indicating whether adaptive learning reate is used in the ADAM algorithm More...
 
optimization_aglorithms alg
 The optimization algorithm to be used in the optimization. More...
 
std::vector< intblock_end
 
std::vector< intblock_type
 
std::vector< Gate * > children
 list of child gates to be applied after this current gate More...
 
double circuit_simulation_time
 Time spent on circuit simulation/cost function evaluation. More...
 
int control_qbit
 The index of the qubit which acts as a control qubit (control_qbit >= 0) in controlled operations. More...
 
double convergence_threshold
 The convergence threshold in the optimization process. More...
 
double correction1_scale
 prefactor of the single-bitflip errors in the cost function. (see Eq. (21) in arXiv:2210.09191) More...
 
double correction2_scale
 prefactor of the double-bitflip errors in the cost function. (see Eq. (21) in arXiv:2210.09191) More...
 
cost_function_type cost_fnc
 The chosen variant of the cost function. More...
 
double CPU_time
 time spent on optimization More...
 
double current_minimum
 The current minimum of the optimization problem. More...
 
double decomposition_error
 error of the final decomposition More...
 
bool decomposition_finalized
 The optimized parameters for the gates. More...
 
int finalizing_gates_num
 number of finalizing (deterministic) opertaions rotating the disentangled qubits into state |0>. More...
 
int finalizing_parameter_num
 the number of the finalizing (deterministic) parameters of gates rotating the disentangled qubits into state |0>. More...
 
int fragmentation_type
 
bool fragmented
 boolean variable indicating whether the circuit was already partitioned or not More...
 
std::vector< Gate * > gates
 The list of stored gates. More...
 
std::mt19937 gen
 Standard mersenne_twister_engine seeded with rd() More...
 
double global_target_minimum
 The global target minimum of the optimization problem. More...
 
std::map< int, intidentical_blocks
 A map of <int n: int num> indicating that how many identical successive blocks should be used in the disentanglement of the nth qubit from the others. More...
 
guess_type initial_guess
 type to guess the initial values for the optimization. Possible values: ZEROS=0, RANDOM=1, CLOSE_TO_ZERO=2 More...
 
std::vector< std::vector< int > > involved_qbits
 
std::map< int, intiteration_loops
 A map of <int n: int num> indicating the number of iteration in each step of the decomposition. More...
 
int layer_num
 number of gate layers More...
 
int matrix_size
 The size N of the NxN matrix associated with the operations. More...
 
int max_fusion
 maximal number of qubits in partitions More...
 
std::map< int, intmax_layer_num
 A map of <int n: int num> indicating that how many layers should be used in the subdecomposition process for the subdecomposing of the nth qubits. More...
 
int max_outer_iterations
 Maximal number of iterations allowed in the optimization process. More...
 
std::string name
 A string labeling the gate operation. More...
 
int num_threads
 Store the number of OpenMP threads. (During the calculations OpenMP multithreading is turned off.) More...
 
int number_of_iters
 number of iterations More...
 
bool optimization_problem_solved
 logical value describing whether the optimization problem was solved or not More...
 
bool optimize_layer_num
 logical value. Set true to optimize the minimum number of gate layers required in the decomposition, or false when the predefined maximal number of layer gates is used (ideal for general unitaries). More...
 
Matrix_real optimized_parameters_mtx
 The optimized parameters for the gates. More...
 
int parameter_num
 the number of free parameters of the operation More...
 
int parameter_start_idx
 the index in the parameter array (corrensponding to the encapsulated circuit) where the gate parameters begin (if gates are placed into a circuit a single parameter array is used to execute the whole circuit) More...
 
std::vector< Gate * > parents
 list of parent gates to be applied in the circuit prior to this current gate More...
 
double prev_cost_fnv_val
 the previous value of the cost funtion to be used to evaluate bitflip errors in the cost funtion (see Eq. (21) in arXiv:2210.09191) More...
 
int qbit_num
 number of qubits spanning the matrix of the operation More...
 
double radius
 parameter to contron the radius of parameter randomization around the curren tminimum More...
 
double randomization_rate
 randomization rate More...
 
int target_qbit
 The index of the qubit on which the operation acts (target_qbit >= 0) More...
 
int trace_offset
 The offset in the first columns from which the "trace" is calculated. In this case Tr(A) = sum_(i-offset=j) A_{ij}. More...
 
gate_type type
 The type of the operation (see enumeration gate_type) More...
 
Matrix Umtx
 The unitary to be decomposed. More...
 

Detailed Description

A base class to determine the decomposition of an N-qubit unitary into a sequence of CNOT and U3 gates.

This class contains the non-template implementation of the decomposition class.

Definition at line 85 of file Optimization_Interface.h.

Constructor & Destructor Documentation

◆ Optimization_Interface() [1/2]

Optimization_Interface::Optimization_Interface ( )

Nullary constructor of the class.

Returns
An instance of the class

Definition at line 48 of file Optimization_Interface.cpp.

◆ Optimization_Interface() [2/2]

Optimization_Interface::Optimization_Interface ( Matrix  Umtx_in,
int  qbit_num_in,
bool  optimize_layer_num_in,
std::map< std::string, Config_Element > &  config,
guess_type  initial_guess_in = CLOSE_TO_ZERO,
int  accelerator_num_in = 0 
)

Constructor of the class.

Parameters
Umtx_inThe unitary matrix to be decomposed
qbit_num_inThe number of qubits spanning the unitary Umtx
optimize_layer_num_inOptional logical value. If true, then the optimization tries to determine the lowest number of the layers needed for the decomposition. If False (default), the optimization is performed for the maximal number of layers.
config_inA map that can be used to set hyperparameters during the process
initial_guess_inEnumeration element indicating the method to guess initial values for the optimization. Possible values: 'zeros=0' ,'random=1', 'close_to_zero=2'
Returns
An instance of the class
Parameters
Umtx_inThe unitary matrix to be decomposed
qbit_num_inThe number of qubits spanning the unitary Umtx
optimize_layer_num_inOptional logical value. If true, then the optimization tries to determine the lowest number of the layers needed for the decomposition. If False (default), the optimization is performed for the maximal number of layers.
initial_guess_inEnumeration element indicating the method to guess initial values for the optimization. Possible values: 'zeros=0' ,'random=1', 'close_to_zero=2'
Returns
An instance of the class

Definition at line 105 of file Optimization_Interface.cpp.

◆ ~Optimization_Interface()

Optimization_Interface::~Optimization_Interface ( )
virtual

Destructor of the class.

Definition at line 177 of file Optimization_Interface.cpp.

Here is the call graph for this function:

Member Function Documentation

◆ add_adaptive()

void Gates_block::add_adaptive ( int  target_qbit,
int  control_qbit 
)
inherited

Append a Adaptive gate to the list of gates.

Parameters
target_qbitThe identification number of the targt qubit. (0 <= target_qbit <= qbit_num-1)
control_qbitThe identification number of the control qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 1553 of file Gates_block.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ add_adaptive_to_front()

void Gates_block::add_adaptive_to_front ( int  target_qbit,
int  control_qbit 
)
inherited

Add a Adaptive gate to the front of the list of gates.

Parameters
target_qbitThe identification number of the targt qubit. (0 <= target_qbit <= qbit_num-1)
control_qbitThe identification number of the control qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 1568 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_ch()

void Gates_block::add_ch ( int  target_qbit,
int  control_qbit 
)
inherited

Append a CH gate (i.e.

controlled Hadamard gate) gate to the list of gates

Parameters
control_qbitThe identification number of the control qubit. (0 <= target_qbit <= qbit_num-1)
target_qbitThe identification number of the target qubit. (0 <= target_qbit <= qbit_num-1)

controlled Hadamard gate) operation to the list of gates

Parameters
control_qbitThe identification number of the control qubit. (0 <= target_qbit <= qbit_num-1)
target_qbitThe identification number of the target qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 1414 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_ch_to_front()

void Gates_block::add_ch_to_front ( int  target_qbit,
int  control_qbit 
)
inherited

Add a CH gate (i.e.

controlled Hadamard gate) gate to the front of the list of gates

Parameters
control_qbitThe identification number of the control qubit. (0 <= target_qbit <= qbit_num-1)
target_qbitThe identification number of the target qubit. (0 <= target_qbit <= qbit_num-1)

controlled Hadamard gate) operation to the front of the list of gates

Parameters
control_qbitThe identification number of the control qubit. (0 <= target_qbit <= qbit_num-1)
target_qbitThe identification number of the target qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 1431 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_child()

void Gate::add_child ( Gate child)
inherited

Call to add a child gate to the current gate.

Parameters
childThe parent gate of the current gate.

Definition at line 426 of file Gate.cpp.

Here is the caller graph for this function:

◆ add_cnot()

void Gates_block::add_cnot ( int  target_qbit,
int  control_qbit 
)
inherited

Append a CNOT gate gate to the list of gates.

Append a C_NOT gate operation to the list of gates.

Parameters
control_qbitThe identification number of the control qubit. (0 <= target_qbit <= qbit_num-1)
target_qbitThe identification number of the target qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 1100 of file Gates_block.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ add_cnot_to_front()

void Gates_block::add_cnot_to_front ( int  target_qbit,
int  control_qbit 
)
inherited

Add a C_NOT gate gate to the front of the list of gates.

Add a C_NOT gate operation to the front of the list of gates.

Parameters
control_qbitThe identification number of the control qubit. (0 <= target_qbit <= qbit_num-1)
target_qbitThe identification number of the target qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 1117 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_composite()

void Gates_block::add_composite ( )
inherited

Append a Composite gate to the list of gates.

Definition at line 1524 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_composite_to_front()

void Gates_block::add_composite_to_front ( )
inherited

Add a Composite gate to the front of the list of gates.

Definition at line 1536 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_crot()

void Gates_block::add_crot ( int  target_qbit,
int  control_qbit,
crot_type  subtype_in 
)
inherited

Append a CNOT gate gate to the list of gates.

Append a RY gate to the list of gates.

Parameters
control_qbitThe identification number of the control qubit. (0 <= target_qbit <= qbit_num-1)
target_qbitThe identification number of the target qubit. (0 <= target_qbit <= qbit_num-1)
target_qbitThe identification number of the targt qubit. (0 <= target_qbit <= qbit_num-1)
control_qbitThe identification number of the control qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 1006 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_crot_to_front()

void Gates_block::add_crot_to_front ( int  target_qbit,
int  control_qbit,
crot_type  subtype_in 
)
inherited

Add a C_NOT gate gate to the front of the list of gates.

Add a RY gate to the front of the list of gates.

Parameters
control_qbitThe identification number of the control qubit. (0 <= target_qbit <= qbit_num-1)
target_qbitThe identification number of the target qubit. (0 <= target_qbit <= qbit_num-1)
target_qbitThe identification number of the targt qubit. (0 <= target_qbit <= qbit_num-1)
control_qbitThe identification number of the control qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 1022 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_cry()

void Gates_block::add_cry ( int  target_qbit,
int  control_qbit 
)
inherited

Append a CRY gate to the list of gates.

Parameters
target_qbitThe identification number of the targt qubit. (0 <= target_qbit <= qbit_num-1)
control_qbitThe identification number of the control qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 974 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_cry_to_front()

void Gates_block::add_cry_to_front ( int  target_qbit,
int  control_qbit 
)
inherited

Add a CRY gate to the front of the list of gates.

Parameters
target_qbitThe identification number of the targt qubit. (0 <= target_qbit <= qbit_num-1)
control_qbitThe identification number of the control qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 990 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_cz()

void Gates_block::add_cz ( int  target_qbit,
int  control_qbit 
)
inherited

Append a CZ gate gate to the list of gates.

Append a CZ gate operation to the list of gates.

Parameters
control_qbitThe identification number of the control qubit. (0 <= target_qbit <= qbit_num-1)
target_qbitThe identification number of the target qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 1135 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_cz_nu()

void Gates_block::add_cz_nu ( int  target_qbit,
int  control_qbit 
)
inherited

Append a CZ_NU gate to the list of gates.

Parameters
target_qbitThe identification number of the targt qubit. (0 <= target_qbit <= qbit_num-1)
control_qbitThe identification number of the control qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 1037 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_cz_nu_to_front()

void Gates_block::add_cz_nu_to_front ( int  target_qbit,
int  control_qbit 
)
inherited

Add a CZ_NU gate to the front of the list of gates.

Parameters
target_qbitThe identification number of the targt qubit. (0 <= target_qbit <= qbit_num-1)
control_qbitThe identification number of the control qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 1053 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_cz_to_front()

void Gates_block::add_cz_to_front ( int  target_qbit,
int  control_qbit 
)
inherited

Add a CZ gate gate to the front of the list of gates.

Add a CZ gate operation to the front of the list of gates.

Parameters
control_qbitThe identification number of the control qubit. (0 <= target_qbit <= qbit_num-1)
target_qbitThe identification number of the target qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 1152 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_finalyzing_layer()

void Optimization_Interface::add_finalyzing_layer ( )
virtual

Call to add further layer to the gate structure used in the subdecomposition.

Reimplemented in N_Qubit_Decomposition_adaptive.

Definition at line 266 of file Optimization_Interface.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ add_gate()

void Gates_block::add_gate ( Gate gate)
inherited

Append a general gate to the list of gates.

Parameters
gateA pointer to a class Gate describing an gate.
gateA pointer to a class Gate describing a gate operation.

Definition at line 1584 of file Gates_block.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ add_gate_nums()

void Gates_block::add_gate_nums ( std::map< std::string, int > &  gate_nums)
inherited

Call to add the number of the individual gate types in the circuit to the map given in the argument.

Parameters
Amap<gate_name, gate_count> describing the number of the individual gate types

Definition at line 1675 of file Gates_block.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ add_gate_to_front()

void Gates_block::add_gate_to_front ( Gate gate)
inherited

Add an gate to the front of the list of gates.

Add a gate to the front of the list of gates.

Parameters
gateA pointer to a class Gate describing an gate.
gateA pointer to a class Gate describing a gate.

Definition at line 1614 of file Gates_block.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ add_gates()

void Gates_block::add_gates ( std::vector< Gate *>  gates_in)
inherited

Append a list of gates to the list of gates.

Parameters
gates_inA list of gate class instances.
gates_inA list of operation class instances.

Definition at line 1445 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_gates_to_front()

void Gates_block::add_gates_to_front ( std::vector< Gate *>  gates_in)
inherited

Add an array of gates to the front of the list of gates.

Parameters
gates_inA list of gate class instances.
gates_inA list of operation class instances.

Definition at line 1458 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_h()

void Gates_block::add_h ( int  target_qbit)
inherited

Append a Hadamard gate to the list of gates.

Parameters
target_qbitThe identification number of the targt qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 1166 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_h_to_front()

void Gates_block::add_h_to_front ( int  target_qbit)
inherited

Add a Hadamard gate to the front of the list of gates.

Parameters
target_qbitThe identification number of the targt qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 1179 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_on()

void Gates_block::add_on ( )
inherited

Append a ON gate to the list of gates.

Definition at line 1498 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_on_to_front()

void Gates_block::add_on_to_front ( )
inherited

Add a OUN gate to the front of the list of gates.

Add a ON gate to the front of the list of gates.

Definition at line 1510 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_parent()

void Gate::add_parent ( Gate parent)
inherited

Call to add a parent gate to the current gate.

Parameters
parentThe parent gate of the current gate.

Definition at line 409 of file Gate.cpp.

Here is the caller graph for this function:

◆ add_r()

void Gates_block::add_r ( int  target_qbit)
inherited

Append a R gate to the list of gates.

Parameters
target_qbitThe identification number of the targt qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 914 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_r_to_front()

void Gates_block::add_r_to_front ( int  target_qbit)
inherited

Add a R gate to the front of the list of gates.

Parameters
target_qbitThe identification number of the targt qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 927 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_rx()

void Gates_block::add_rx ( int  target_qbit)
inherited

Append a RX gate to the list of gates.

Parameters
target_qbitThe identification number of the targt qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 887 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_rx_to_front()

void Gates_block::add_rx_to_front ( int  target_qbit)
inherited

Add a RX gate to the front of the list of gates.

Parameters
target_qbitThe identification number of the targt qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 900 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_ry()

void Gates_block::add_ry ( int  target_qbit)
inherited

Append a RY gate to the list of gates.

Parameters
target_qbitThe identification number of the targt qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 942 of file Gates_block.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ add_ry_to_front()

void Gates_block::add_ry_to_front ( int  target_qbit)
inherited

Add a RY gate to the front of the list of gates.

Parameters
target_qbitThe identification number of the targt qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 956 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_rz()

void Gates_block::add_rz ( int  target_qbit)
inherited

Append a RZ gate to the list of gates.

Parameters
target_qbitThe identification number of the targt qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 1069 of file Gates_block.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ add_rz_to_front()

void Gates_block::add_rz_to_front ( int  target_qbit)
inherited

Add a RZ gate to the front of the list of gates.

Parameters
target_qbitThe identification number of the targt qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 1082 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_sx()

void Gates_block::add_sx ( int  target_qbit)
inherited

Append a SX gate to the list of gates.

Parameters
target_qbitThe identification number of the targt qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 1347 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_sx_to_front()

void Gates_block::add_sx_to_front ( int  target_qbit)
inherited

Add a SX gate to the front of the list of gates.

Parameters
target_qbitThe identification number of the targt qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 1360 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_syc()

void Gates_block::add_syc ( int  target_qbit,
int  control_qbit 
)
inherited

Append a Sycamore gate (i.e.

Append a Sycamore gate operation to the list of gates.

controlled Hadamard gate) gate to the list of gates

Parameters
control_qbitThe identification number of the control qubit. (0 <= target_qbit <= qbit_num-1)
target_qbitThe identification number of the target qubit. (0 <= target_qbit <= qbit_num-1)
control_qbitThe identification number of the control qubit. (0 <= target_qbit <= qbit_num-1)
target_qbitThe identification number of the target qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 1379 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_syc_to_front()

void Gates_block::add_syc_to_front ( int  target_qbit,
int  control_qbit 
)
inherited

Add a Sycamore gate (i.e.

Add a Sycamore gate operation to the front of the list of gates.

controlled Hadamard gate) gate to the front of the list of gates

Parameters
control_qbitThe identification number of the control qubit. (0 <= target_qbit <= qbit_num-1)
target_qbitThe identification number of the target qubit. (0 <= target_qbit <= qbit_num-1)
control_qbitThe identification number of the control qubit. (0 <= target_qbit <= qbit_num-1)
target_qbitThe identification number of the target qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 1396 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_t()

void Gates_block::add_t ( int  target_qbit)
inherited

Append a T gate to the list of gates.

Parameters
target_qbitThe identification number of the targt qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 1285 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_t_to_front()

void Gates_block::add_t_to_front ( int  target_qbit)
inherited

Add a T gate to the front of the list of gates.

Parameters
target_qbitThe identification number of the targt qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 1298 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_tdg()

void Gates_block::add_tdg ( int  target_qbit)
inherited

Append a Tdg gate to the list of gates.

Parameters
target_qbitThe identification number of the targt qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 1315 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_tdg_to_front()

void Gates_block::add_tdg_to_front ( int  target_qbit)
inherited

Add a Tdg gate to the front of the list of gates.

Parameters
target_qbitThe identification number of the targt qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 1328 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_u1()

void Gates_block::add_u1 ( int  target_qbit)
inherited

Append a U1 gate to the list of gates.

Parameters
target_qbitThe identification number of the target qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 808 of file Gates_block.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ add_u1_to_front()

void Gates_block::add_u1_to_front ( int  target_qbit)
inherited

Add a U1 gate to the front of the list of gates.

Parameters
target_qbitThe identification number of the target qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 821 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_u2()

void Gates_block::add_u2 ( int  target_qbit)
inherited

Append a U2 gate to the list of gates.

Parameters
target_qbitThe identification number of the target qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 834 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_u2_to_front()

void Gates_block::add_u2_to_front ( int  target_qbit)
inherited

Add a U2 gate to the front of the list of gates.

Parameters
target_qbitThe identification number of the target qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 847 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_u3()

void Gates_block::add_u3 ( int  target_qbit)
inherited

Append a U3 gate to the list of gates.

Parameters
target_qbitThe identification number of the targt qubit. (0 <= target_qbit <= qbit_num-1)
ThetaThe Theta parameter of the U3 gate
PhiThe Phi parameter of the U3 gate
LambdaThe Lambda parameter of the U3 gate
target_qbitThe identification number of the targt qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 860 of file Gates_block.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ add_u3_to_front()

void Gates_block::add_u3_to_front ( int  target_qbit)
inherited

Add a U3 gate to the front of the list of gates.

Parameters
target_qbitThe identification number of the targt qubit. (0 <= target_qbit <= qbit_num-1)
ThetaThe Theta parameter of the U3 gate
PhiThe Phi parameter of the U3 gate
LambdaThe Lambda parameter of the U3 gate
target_qbitThe identification number of the targt qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 873 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_un()

void Gates_block::add_un ( )
inherited

Append a UN gate to the list of gates.

Definition at line 1472 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_un_to_front()

void Gates_block::add_un_to_front ( )
inherited

Add a UN gate to the front of the list of gates.

Definition at line 1484 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_x()

void Gates_block::add_x ( int  target_qbit)
inherited

Append a X gate to the list of gates.

Parameters
target_qbitThe identification number of the targt qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 1197 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_x_to_front()

void Gates_block::add_x_to_front ( int  target_qbit)
inherited

Add a X gate to the front of the list of gates.

Parameters
target_qbitThe identification number of the targt qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 1210 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_y()

void Gates_block::add_y ( int  target_qbit)
inherited

Append a Y gate to the list of gates.

Parameters
target_qbitThe identification number of the targt qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 1226 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_y_to_front()

void Gates_block::add_y_to_front ( int  target_qbit)
inherited

Add a Y gate to the front of the list of gates.

Parameters
target_qbitThe identification number of the targt qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 1239 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_z()

void Gates_block::add_z ( int  target_qbit)
inherited

Append a Z gate to the list of gates.

Parameters
target_qbitThe identification number of the targt qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 1255 of file Gates_block.cpp.

Here is the call graph for this function:

◆ add_z_to_front()

void Gates_block::add_z_to_front ( int  target_qbit)
inherited

Add a Z gate to the front of the list of gates.

Parameters
target_qbitThe identification number of the targt qubit. (0 <= target_qbit <= qbit_num-1)

Definition at line 1268 of file Gates_block.cpp.

Here is the call graph for this function:

◆ apply_derivate_to()

std::vector< Matrix > Gates_block::apply_derivate_to ( Matrix_real parameters_mtx_in,
Matrix input,
int  parallel 
)
virtualinherited

Call to evaluate the derivate of the circuit on an inout with respect to all of the free parameters.

Parameters
parametersAn array of the input parameters.
inputThe input array on which the gate is applied
parallelSet 0 for sequential execution, 1 for parallel execution with OpenMP (NOT IMPLEMENTED YET) and 2 for parallel with TBB (optional)

Reimplemented from Gate.

Definition at line 705 of file Gates_block.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ apply_from_right() [1/2]

void Gates_block::apply_from_right ( Matrix_real parameters_mtx,
Matrix input 
)
virtualinherited

Call to apply the gate on the input array/matrix by input*CNOT.

Call to apply the gate on the input array/matrix by input*Gate_block.

Parameters
inputThe input array on which the gate is applied

Reimplemented in Composite.

Definition at line 569 of file Gates_block.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ apply_from_right() [2/2]

void Gate::apply_from_right ( Matrix input)
virtualinherited

Call to apply the gate on the input array/matrix by input*Gate.

Parameters
inputThe input array on which the gate is applied

Reimplemented in SX, H, X, Y, Z, T, Tdg, SYC, CH, CNOT, and CZ.

Definition at line 285 of file Gate.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ apply_gate()

Matrix Decomposition_Base::apply_gate ( Matrix gate_mtx,
Matrix input_matrix 
)
inherited

Apply an gates on the input matrix.

Parameters
gate_mtxThe matrix of the gate.
input_matrixThe input matrix to be transformed.
Returns
Returns with the transformed matrix

Definition at line 683 of file Decomposition_Base.cpp.

Here is the call graph for this function:

◆ apply_global_phase_factor() [1/2]

void Decomposition_Base::apply_global_phase_factor ( QGD_Complex16  global_phase_factor,
Matrix u3_gate 
)
inherited

Call to apply the global phase to a matrix.

Call to apply global phase of U3 matrices to matrix.

Returns
Returns with the minimum of the cost function
Parameters
global_phase_factorThe value of the phase

Definition at line 939 of file Decomposition_Base.cpp.

Here is the call graph for this function:

◆ apply_global_phase_factor() [2/2]

void Decomposition_Base::apply_global_phase_factor ( )
inherited

Call to apply the current global phase to the unitary matrix.

Parameters
global_phase_factorThe value of the phase

Definition at line 948 of file Decomposition_Base.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ apply_kernel_from_right()

void Gate::apply_kernel_from_right ( Matrix u3_1qbit,
Matrix input 
)
protectedinherited

Call to apply the gate kernel on the input state or unitary from right (no AVX support)

Parameters
u3_1qbitThe 2x2 kernel of the gate operation
inputThe input matrix on which the transformation is applied
derivSet true to apply derivate transformation, false otherwise

Definition at line 613 of file Gate.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ apply_kernel_to()

void Gate::apply_kernel_to ( Matrix u3_1qbit,
Matrix input,
bool  deriv = false,
int  parallel = 0 
)
protectedinherited

Call to apply the gate kernel on the input state or unitary with optional AVX support.

Parameters
u3_1qbitThe 2x2 kernel of the gate operation
inputThe input matrix on which the transformation is applied
derivSet true to apply derivate transformation, false otherwise (optional)
parallelSet true to apply parallel kernels, false otherwise (optional)
parallelSet 0 for sequential execution (default), 1 for parallel execution with OpenMP and 2 for parallel with TBB (optional)
u3_1qbitThe 2x2 kernel of the gate operation
inputThe input matrix on which the transformation is applied
derivSet true to apply derivate transformation, false otherwise (optional)
derivSet true to apply parallel kernels, false otherwise (optional)
parallelSet 0 for sequential execution (default), 1 for parallel execution with OpenMP and 2 for parallel with TBB (optional)

Definition at line 537 of file Gate.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ apply_to() [1/2]

void Gates_block::apply_to ( Matrix_real parameters_mtx_in,
Matrix input,
int  parallel = 0 
)
virtualinherited

Call to apply the gate on the input array/matrix Gates_block*input.

Parameters
parametersAn array of the input parameters.
inputThe input array on which the gate is applied
parallelSet 0 for sequential execution, 1 for parallel execution with OpenMP and 2 for parallel with TBB (optional)
parametersAn array of parameters to calculate the matrix of the U3 gate.
inputThe input array on which the gate is applied
parallelSet 0 for sequential execution, 1 for parallel execution with OpenMP and 2 for parallel with TBB (optional)

Reimplemented from Gate.

Reimplemented in Composite.

Definition at line 235 of file Gates_block.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ apply_to() [2/2]

void Gate::apply_to ( Matrix input,
int  parallel 
)
virtualinherited

Call to apply the gate on the input array/matrix.

Parameters
inputThe input array on which the gate is applied
parallelSet 0 for sequential execution, 1 for parallel execution with OpenMP and 2 for parallel with TBB (optional)

Reimplemented in SX, H, X, Y, Z, T, Tdg, CH, CZ, SYC, and CNOT.

Definition at line 237 of file Gate.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ apply_to_list() [1/2]

void Gates_block::apply_to_list ( Matrix_real parameters_mtx,
std::vector< Matrix > &  inputs,
int  parallel 
)
virtualinherited

Call to apply the gate on the input array/matrix by U3*input.

Parameters
parametersAn array of parameters to calculate the matrix of the U3 gate.
inputsThe input array on which the gate is applied
parallelSet 0 for sequential execution, 1 for parallel execution with OpenMP and 2 for parallel with TBB (optional)
parametersAn array of parameters to calculate the matrix of the U3 gate.
inputThe input array on which the gate is applied

Reimplemented from Gate.

Definition at line 202 of file Gates_block.cpp.

Here is the call graph for this function:

◆ apply_to_list() [2/2]

void Gate::apply_to_list ( std::vector< Matrix > &  inputs,
int  parallel 
)
virtualinherited

Call to apply the gate on a list of inputs.

Parameters
inputsThe input array on which the gate is applied
parallelSet 0 for sequential execution, 1 for parallel execution with OpenMP and 2 for parallel with TBB (optional)

Definition at line 187 of file Gate.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ calc_decomposition_error()

void Optimization_Interface::calc_decomposition_error ( Matrix decomposed_matrix)

Calculate the error of the decomposition according to the spectral norm of \( U-U_{approx} \), where \( U_{approx} \) is the unitary produced by the decomposing quantum cirquit.

The calculated error is stored in the attribute decomposition_error.

Parameters
decomposed_matrixThe decomposed matrix, i.e. the result of the decomposing gate structure applied on the initial unitary.
Returns
Returns with the calculated spectral norm.
Parameters
decomposed_matrixThe decomposed matrix, i.e. the result of the decomposing gate structure applied on the initial unitary.
Returns
Returns with the calculated spectral norm.

Definition at line 291 of file Optimization_Interface.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ calc_one_qubit_u3() [1/2]

Matrix Gate::calc_one_qubit_u3 ( double  ThetaOver2,
double  Phi,
double  Lambda 
)
virtualinherited

Calculate the matrix of a U3 gate gate corresponding to the given parameters acting on a single qbit space.

Parameters
ThetaReal parameter standing for the parameter theta.
PhiReal parameter standing for the parameter phi.
LambdaReal parameter standing for the parameter lambda.
Returns
Returns with the matrix of the one-qubit matrix.
Parameters
ThetaOver2Real parameter standing for the parameter theta.
PhiReal parameter standing for the parameter phi.
LambdaReal parameter standing for the parameter lambda.
Returns
Returns with the matrix of the one-qubit matrix.

Definition at line 695 of file Gate.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ calc_one_qubit_u3() [2/2]

Matrix Gate::calc_one_qubit_u3 ( )
virtualinherited

Calculate the matrix of the constans gates.

Returns
Returns with the matrix of the one-qubit matrix.

Reimplemented in SX, H, X, Y, Z, T, Tdg, CH, CNOT, and CZ.

Definition at line 750 of file Gate.cpp.

Here is the caller graph for this function:

◆ calculate_new_global_phase_factor()

void Decomposition_Base::calculate_new_global_phase_factor ( QGD_Complex16  global_phase_factor_new)
inherited

Calculate the new global phase of the Unitary matrix after removing a trivial U3 matrix.

Call to calculate new global phase.

Parameters
global_phase_factor_newglobal phase calculated from the product of two U3 matrices
global_phase_factorThe value of the phase

Definition at line 912 of file Decomposition_Base.cpp.

Here is the call graph for this function:

◆ check_optimization_solution()

bool Decomposition_Base::check_optimization_solution ( )
inherited

check_optimization_solution

Checks the convergence of the optimization problem.

Returns
Returns with true if the target global minimum was reached during the optimization process, or false otherwise.

Definition at line 587 of file Decomposition_Base.cpp.

Here is the caller graph for this function:

◆ clear_children()

void Gate::clear_children ( )
inherited

Call to erase data on children.

Definition at line 441 of file Gate.cpp.

Here is the caller graph for this function:

◆ clear_parents()

void Gate::clear_parents ( )
inherited

Call to erase data on parents.

Definition at line 451 of file Gate.cpp.

Here is the caller graph for this function:

◆ clone()

Gates_block * Gates_block::clone ( )
virtualinherited

Create a clone of the present class.

Returns
Return with a pointer pointing to the cloned object.

Reimplemented from Gate.

Reimplemented in Sub_Matrix_Decomposition, and Composite.

Definition at line 2357 of file Gates_block.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ combine()

void Gates_block::combine ( Gates_block op_block)
inherited

Call to append the gates of an gate block to the current block.

Call to append the gates of a gate block to the current circuit.

Parameters
op_blockA pointer to an instance of class Gate_block
op_blockA pointer to an instance of class Gates_block

Definition at line 2292 of file Gates_block.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ contains_adaptive_gate() [1/2]

bool Gates_block::contains_adaptive_gate ( )
inherited

Call to determine, whether the circuit contains daptive gate or not.

Returns
Return with true if the circuit contains an adaptive gate.

Definition at line 2423 of file Gates_block.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ contains_adaptive_gate() [2/2]

bool Gates_block::contains_adaptive_gate ( int  idx)
inherited

Call to determine, whether the sub-circuit at a given position in the circuit contains daptive gate or not.

Parameters
idxThe position of the gate to be checked.
Returns
Return with true if the circuit contains an adaptive gate.

Definition at line 2450 of file Gates_block.cpp.

Here is the call graph for this function:

◆ create_remapped_circuit() [1/2]

Gates_block * Gates_block::create_remapped_circuit ( const std::map< int, int > &  qbit_map)
inherited

Call to create a new circuit with remapped qubits.

Parameters
qbit_mapThe map to reorder the qbits in a form of map: {int(initial_qbit): int(remapped_qbit)}.
Returns
Returns with the remapped circuit

Definition at line 2030 of file Gates_block.cpp.

Here is the caller graph for this function:

◆ create_remapped_circuit() [2/2]

Gates_block * Gates_block::create_remapped_circuit ( const std::map< int, int > &  qbit_map,
const int  qbit_num_ 
)
inherited

Call to create a new circuit with remapped qubits.

Parameters
qbit_mapThe map to reorder the qbits in a form of map: {int(initial_qbit): int(remapped_qbit)}. .
qbit_numThe number of qubits in the remapped circuit
Returns
Returns with the remapped circuit

Definition at line 2044 of file Gates_block.cpp.

Here is the call graph for this function:

◆ determine_children()

void Gates_block::determine_children ( Gate gate)
inherited

Call to obtain the child gates in the circuit.

A child gate needs to be applied after the given gate. The children gates are stored via the "children" attribute of the gate instance

Parameters
gateThe gate for which the children are determined.

Definition at line 2770 of file Gates_block.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ determine_parents()

void Gates_block::determine_parents ( Gate gate)
inherited

Call to obtain the parent gates in the circuit.

A parent gate needs to be applied prior to the given gate. The parent gates are stored via the "parents" attribute of the gate instance

Parameters
gateThe gate for which the parents are determined.

Definition at line 2724 of file Gates_block.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ export_current_cost_fnc() [1/3]

void Optimization_Interface::export_current_cost_fnc ( double  current_minimum)

Call to print out into a file the current cost function and the second Rényi entropy on the subsystem made of qubits 0 and 1.

Parameters stored in the class are used to calculate the Renyi entropy

Parameters
current_minimumThe current minimum (to avoid calculating it again
current_minimumThe current minimum (to avoid calculating it again

Definition at line 195 of file Optimization_Interface.cpp.

Here is the caller graph for this function:

◆ export_current_cost_fnc() [2/3]

void Optimization_Interface::export_current_cost_fnc ( double  current_minimum,
Matrix_real parameters 
)

Call to print out into a file the current cost function and the second Rényi entropy on the subsystem made of qubits 0 and 1.

Parameters
current_minimumThe current minimum (to avoid calculating it again
parametersParameters to be used in the calculations (For Rényi entropy)

Definition at line 208 of file Optimization_Interface.cpp.

Here is the call graph for this function:

◆ export_current_cost_fnc() [3/3]

void Optimization_Interface::export_current_cost_fnc ( double  current_minimum,
Matrix_real parameters,
void *  void_instance 
)
static

Call to print out into a file the current cost function and the second Rényi entropy on the subsystem made of qubits 0 and 1.

Parameters
current_minimumThe current minimum (to avoid calculating it again
parametersParameters to be used in the calculations (For Rényi entropy)
instanceA pointer pointing ti the current class instance.

Definition at line 252 of file Optimization_Interface.cpp.

Here is the call graph for this function:

◆ export_unitary()

void Decomposition_Base::export_unitary ( std::string &  filename)
inherited

exports unitary matrix to binary file

Call to export the unitary (with possible phase shift) into a binary file.

Parameters
filenamefile to be exported to
filenameThe path to the file where the unitary is expored

Definition at line 959 of file Decomposition_Base.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ extract_gates()

int Gates_block::extract_gates ( Gates_block op_block)
inherited

Call to extract the gates stored in the class.

Parameters
op_blockAn instance of Gates_block class in which the gates will be stored. (The current gates will be erased)
Returns
Return with 0 on success.

Definition at line 2382 of file Gates_block.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ extract_parameters()

Matrix_real Gates_block::extract_parameters ( Matrix_real parameters)
virtualinherited

Call to extract parameters from the parameter array corresponding to the circuit, in which the gate is embedded.

Parameters
parametersThe parameter array corresponding to the circuit in which the gate is embedded
Returns
Returns with the array of the extracted parameters.

Reimplemented from Gate.

Definition at line 2895 of file Gates_block.cpp.

Here is the call graph for this function:

◆ final_optimization()

void Optimization_Interface::final_optimization ( )

final optimization procedure improving the accuracy of the decompositin when all the qubits were already disentangled.

Definition at line 383 of file Optimization_Interface.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ fragment_circuit()

void Gates_block::fragment_circuit ( )
inherited

Definition at line 398 of file Gates_block.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ get_accelerator_num()

int Optimization_Interface::get_accelerator_num ( )

Get the number of accelerators to be reserved on DFEs on users demand.

Definition at line 1538 of file Optimization_Interface.cpp.

Here is the caller graph for this function:

◆ get_children()

std::vector< Gate * > Gate::get_children ( )
inherited

Call to get the children of the current gate.

Returns
Returns with the list of the children

Definition at line 474 of file Gate.cpp.

Here is the caller graph for this function:

◆ get_control_qbit()

int Gate::get_control_qbit ( )
inherited

Call to get the index of the control qubit.

Returns
Return with the index of the control qubit (return with -1 if control qubit was not set)

Definition at line 378 of file Gate.cpp.

Here is the caller graph for this function:

◆ get_correction1_scale()

double Optimization_Interface::get_correction1_scale ( )

Call to get the prefactor of the single-bitflip errors in the cost function.

Call to get the pre factor of the single-bitflip errors in the cost function.

(see Eq. (21) in arXiv:2210.09191)

Returns
Returns with the prefactor of the single-bitflip errors in the cost function.

Definition at line 1425 of file Optimization_Interface.cpp.

Here is the caller graph for this function:

◆ get_correction2_scale()

double Optimization_Interface::get_correction2_scale ( )

Call to get the prefactor of the two-bitflip errors in the cost function.

Call to get the pre factor of the two-bitflip errors in the cost function.

(see Eq. (21) in arXiv:2210.09191)

Returns
Returns with the prefactor of the two-bitflip errors in the cost function.

Definition at line 1438 of file Optimization_Interface.cpp.

Here is the caller graph for this function:

◆ get_cost_function_variant()

cost_function_type Optimization_Interface::get_cost_function_variant ( )

Call to get the variant of the cost function used in the calculations.

Definition at line 1274 of file Optimization_Interface.cpp.

Here is the caller graph for this function:

◆ get_current_minimum()

double Decomposition_Base::get_current_minimum ( )
inherited

Call to get the obtained minimum of the cost function.

Returns
Returns with the minimum of the cost function

Definition at line 884 of file Decomposition_Base.cpp.

Here is the caller graph for this function:

◆ get_decomposed_matrix()

Matrix Decomposition_Base::get_decomposed_matrix ( )
inherited

Calculate the decomposed matrix resulted by the effect of the optimized gates on the unitary Umtx.

Returns
Returns with the decomposed matrix.

Definition at line 666 of file Decomposition_Base.cpp.

Here is the call graph for this function:

◆ get_decomposition_error()

double Decomposition_Base::get_decomposition_error ( )
inherited

Call to get the error of the decomposition.

Returns
Returns with the error of the decomposition

Definition at line 871 of file Decomposition_Base.cpp.

◆ get_flat_circuit()

Gates_block * Gates_block::get_flat_circuit ( )
inherited

Method to generate a flat circuit.

A flat circuit is a circuit does not containing subcircuits: there are no Gates_block instances (containing subcircuits) in the resulting circuit. If the original circuit contains subcircuits, the gates in the subcircuits are directly incorporated in the resulting flat circuit.

Definition at line 2857 of file Gates_block.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ get_gate()

Gate * Gates_block::get_gate ( int  idx)
inherited

Call to get the gates stored in the class.

Call to get a gate stored in the class.

Returns
Return with a list of the gates.
Return with a pointer to the gate. (Borrowed reference, dont free the memory)

Definition at line 2278 of file Gates_block.cpp.

Here is the caller graph for this function:

◆ get_gate_num()

int Gates_block::get_gate_num ( )
inherited

Call to get the number of gates grouped in the class.

Returns
Return with the number of the gates grouped in the gate block.

Definition at line 1733 of file Gates_block.cpp.

Here is the caller graph for this function:

◆ get_gate_nums()

std::map< std::string, int > Gates_block::get_gate_nums ( )
inherited

Call to get the number of the individual gate types in the list of gates.

Returns
Returns with a map<gate_name, gate_count> describing the number of the individual gate types

Definition at line 1707 of file Gates_block.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ get_gates()

std::vector< Gate * > Gates_block::get_gates ( )
inherited

Call to get the gates stored in the class.

Returns
Return with a list of the gates.

(The resulting vector contains borrowed pointers to the gates, so they dont need to be deleted.)

Returns
Return with a list of the gates.

Definition at line 2269 of file Gates_block.cpp.

Here is the caller graph for this function:

◆ get_global_phase_factor()

QGD_Complex16 Decomposition_Base::get_global_phase_factor ( )
inherited

Get the global phase of the Unitary matrix.

Call to get global phase.

Returns
The current global phase
Parameters
global_phase_factorThe value of the phase

Definition at line 921 of file Decomposition_Base.cpp.

◆ get_involved_qubits()

std::vector< int > Gates_block::get_involved_qubits ( )
virtualinherited

Call to get the qubits involved in the gates stored in the block of gates.

Returns
Return with a list of the involved qubits
Return with a list of the invovled qubits

Reimplemented from Gate.

Definition at line 2237 of file Gates_block.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ get_matrix() [1/4]

Matrix Gates_block::get_matrix ( Matrix_real parameters)
virtualinherited

Call to retrieve the gate matrix (Which is the product of all the gate matrices stored in the gate block)

Call to retrieve the operation matrix (Which is the product of all the operation matrices stored in the operation block)

Parameters
parametersAn array pointing to the parameters of the gates
Returns
Returns with the gate matrix
Parameters
parametersAn array pointing to the parameters of the gates
Returns
Returns with the operation matrix

Reimplemented from Gate.

Definition at line 155 of file Gates_block.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ get_matrix() [2/4]

Matrix Gates_block::get_matrix ( Matrix_real parameters,
int  parallel 
)
virtualinherited

Call to retrieve the gate matrix (Which is the product of all the gate matrices stored in the gate block)

Call to retrieve the operation matrix (Which is the product of all the operation matrices stored in the operation block)

Parameters
parametersAn array pointing to the parameters of the gates
parallelSet 0 for sequential execution, 1 for parallel execution with OpenMP and 2 for parallel with TBB (optional)
Returns
Returns with the gate matrix
Parameters
parametersAn array pointing to the parameters of the gates
parallelSet 0 for sequential execution, 1 for parallel execution with OpenMP and 2 for parallel with TBB (optional)
Returns
Returns with the operation matrix

Reimplemented from Gate.

Definition at line 171 of file Gates_block.cpp.

Here is the call graph for this function:

◆ get_matrix() [3/4]

Matrix Gate::get_matrix ( )
virtualinherited

Call to retrieve the operation matrix.

Returns
Returns with a matrix of the operation

Reimplemented in SX, CH, CZ, H, X, Y, Z, CNOT, SYC, T, and Tdg.

Definition at line 129 of file Gate.cpp.

Here is the caller graph for this function:

◆ get_matrix() [4/4]

Matrix Gate::get_matrix ( int  parallel)
virtualinherited

Call to retrieve the operation matrix.

Parameters
parallelSet 0 for sequential execution, 1 for parallel execution with OpenMP and 2 for parallel with TBB (optional)
Returns
Returns with the matrix of the operation

Reimplemented in SX, H, X, Y, CH, CZ, SYC, Z, CNOT, T, and Tdg.

Definition at line 141 of file Gate.cpp.

◆ get_name()

std::string Gate::get_name ( )
inherited

Call to get the name label of the gate.

Returns
Returns with the name label of the gate

Definition at line 839 of file Gate.cpp.

Here is the caller graph for this function:

◆ get_num_iters()

int Optimization_Interface::get_num_iters ( )

Get the number of processed iterations during the optimization process.

Get the number of iterations.

Definition at line 1453 of file Optimization_Interface.cpp.

Here is the caller graph for this function:

◆ get_optimized_parameters() [1/2]

Matrix_real Decomposition_Base::get_optimized_parameters ( )
inherited

Call to get the optimized parameters.

Returns
Return with the pointer pointing to the array storing the optimized parameters

Definition at line 623 of file Decomposition_Base.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ get_optimized_parameters() [2/2]

void Decomposition_Base::get_optimized_parameters ( double *  ret)
inherited

Call to get the optimized parameters.

Parameters
retPreallocated array to store the optimized parameters.

Definition at line 633 of file Decomposition_Base.cpp.

Here is the call graph for this function:

◆ get_parallel_configuration()

int Decomposition_Base::get_parallel_configuration ( )
inherited

Get the parallel configuration from the config.

Returns
Returns with the parallel configuration (0 for sequential execution, 1 for parallel execution with OpenMP (NOT IMPLEMENTED YET) and 2 for parallel with TBB (optional))

Definition at line 1017 of file Decomposition_Base.cpp.

Here is the caller graph for this function:

◆ get_parameter_max()

void Gates_block::get_parameter_max ( Matrix_real range_max)
inherited

Definition at line 491 of file Gates_block.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ get_parameter_num()

int Gates_block::get_parameter_num ( )
inherited

Call to get the number of free parameters.

Returns
Return with the number of parameters of the gates grouped in the gate block.

Definition at line 1722 of file Gates_block.cpp.

Here is the caller graph for this function:

◆ get_parameter_start_idx()

int Gate::get_parameter_start_idx ( )
inherited

Call to get the starting index of the parameters in the parameter array corresponding to the circuit in which the current gate is incorporated.

Parameters
start_idxThe starting index

Definition at line 814 of file Gate.cpp.

Here is the caller graph for this function:

◆ get_parents()

std::vector< Gate * > Gate::get_parents ( )
inherited

Call to get the parents of the current gate.

Returns
Returns with the list of the parents

Definition at line 463 of file Gate.cpp.

Here is the caller graph for this function:

◆ get_previous_cost_function_value()

double Optimization_Interface::get_previous_cost_function_value ( )

Call to retrieve the previous value of the cost funtion to be used to evaluate bitflip errors in the cost funtion (see Eq.

(21) in arXiv:2210.09191)

Definition at line 1412 of file Optimization_Interface.cpp.

Here is the caller graph for this function:

◆ get_project_name()

std::string Decomposition_Base::get_project_name ( )
inherited

Call to get the current name of the project.

Returns
Returns the name of the project

Definition at line 894 of file Decomposition_Base.cpp.

◆ get_qbit_num()

int Gate::get_qbit_num ( )
inherited

Call to get the number of qubits composing the unitary.

Returns
Return with the number of qubits composing the unitary

Definition at line 504 of file Gate.cpp.

Here is the caller graph for this function:

◆ get_reduced_density_matrix()

Matrix Gates_block::get_reduced_density_matrix ( Matrix_real parameters_mtx,
Matrix input_state,
matrix_base< int > &  qbit_list_subset 
)
inherited

Call to evaluate the reduced densiy matrix.

Parameters
parametersAn array of parameters to calculate the entropy
input_stateThe input state on which the gate structure is applied
qbit_listSubset of qubits for which the entropy should be calculated. (Should conatin unique elements) Returns with the reduced density matrix.

Definition at line 2477 of file Gates_block.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ get_second_Renyi_entropy()

double Gates_block::get_second_Renyi_entropy ( Matrix_real parameters_mtx,
Matrix input_state,
matrix_base< int > &  qbit_list_subset 
)
inherited

Call to evaluate the seconf Rényi entropy.

The quantum circuit is applied on an input state input. The entropy is evaluated for the transformed state.

Parameters
parametersAn array of parameters to calculate the entropy
input_stateThe input state on which the gate structure is applied
qbit_listSubset of qubits for which the entropy should be calculated. (Should conatin unique elements) Returns with the calculated entropy

Definition at line 2654 of file Gates_block.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ get_target_qbit()

int Gate::get_target_qbit ( )
inherited

Call to get the index of the target qubit.

Returns
Return with the index of the target qubit (return with -1 if target qubit was not set)

Definition at line 370 of file Gate.cpp.

Here is the caller graph for this function:

◆ get_trace_offset()

int Optimization_Interface::get_trace_offset ( )

Get the trace ffset used in the evaluation of the cost function.

Get the trace offset used in the evaluation of the cost function.

Definition at line 1480 of file Optimization_Interface.cpp.

Here is the caller graph for this function:

◆ get_type()

gate_type Gate::get_type ( )
inherited

Call to get the type of the operation.

Returns
Return with the type of the operation (see gate_type for details)

Definition at line 495 of file Gate.cpp.

Here is the caller graph for this function:

◆ get_Umtx()

Matrix Decomposition_Base::get_Umtx ( )
inherited

Call to retrive a pointer to the unitary to be transformed.

Returns
Return with the unitary Umtx

Definition at line 606 of file Decomposition_Base.cpp.

Here is the caller graph for this function:

◆ get_Umtx_size()

int Decomposition_Base::get_Umtx_size ( )
inherited

Call to get the size of the unitary to be transformed.

Returns
Return with the size N of the unitary NxN

Definition at line 615 of file Decomposition_Base.cpp.

◆ import_unitary_from_binary()

Matrix Decomposition_Base::import_unitary_from_binary ( std::string &  filename)
inherited

Import a Unitary matrix from a file.

Call to import the unitary (with possible phase shift) into a binary file.

Parameters
filename.binary file to read
filenameThe path to the file from which the unitary is imported.

Definition at line 985 of file Decomposition_Base.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ Init_max_layer_num()

void Decomposition_Base::Init_max_layer_num ( )
staticinherited

Initializes default layer numbers.

Definition at line 826 of file Decomposition_Base.cpp.

Here is the caller graph for this function:

◆ insert_gate()

void Gates_block::insert_gate ( Gate gate,
int  idx 
)
inherited

Call to insert a gate at a given position.

Parameters
gateA pointer to a class Gate describing a gate.
idxThe position where to insert the gate.

Definition at line 1647 of file Gates_block.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ list_gates() [1/2]

void Decomposition_Base::list_gates ( int  start_index)
inherited

Call to print the gates decomposing the initial unitary.

These gates brings the intial matrix into unity.

Parameters
start_indexThe index of the first gate

Definition at line 241 of file Decomposition_Base.cpp.

Here is the call graph for this function:

◆ list_gates() [2/2]

void Gates_block::list_gates ( const Matrix_real parameters,
int  start_index 
)
inherited

Call to print the list of gates stored in the block of gates for a specific set of parameters.

Parameters
parametersThe parameters of the gates that should be printed.
start_indexThe ordinal number of the first gate.

Definition at line 1743 of file Gates_block.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ optimization_problem() [1/5]

double Decomposition_Base::optimization_problem ( const double *  parameters)
virtualinherited

This is an abstact definition of function giving the cost functions measuring the entaglement of the qubits.

When the qubits are indepent, teh cost function should be zero.

Parameters
parametersAn array of the free parameters to be optimized. (The number of the free paramaters should be equal to the number of parameters in one sub-layer)

Definition at line 575 of file Decomposition_Base.cpp.

◆ optimization_problem() [2/5]

double Optimization_Interface::optimization_problem ( double *  parameters)

Evaluate the optimization problem of the optimization.

Parameters
parametersAn array of the free parameters to be optimized.
Returns
Returns with the cost function.

Definition at line 509 of file Optimization_Interface.cpp.

Here is the caller graph for this function:

◆ optimization_problem() [3/5]

double Optimization_Interface::optimization_problem ( Matrix_real parameters)
virtual

The optimization problem of the final optimization.

Evaluate the optimization problem of the optimization.

Parameters
parametersAn array of the free parameters to be optimized.
Returns
Returns with the cost function.

Reimplemented in Variational_Quantum_Eigensolver_Base.

Definition at line 526 of file Optimization_Interface.cpp.

Here is the call graph for this function:

◆ optimization_problem() [4/5]

double Optimization_Interface::optimization_problem ( Matrix_real  parameters,
void *  void_instance,
Matrix  ret_temp 
)

The optimization problem of the final optimization.

The static cost function of the optimization.

Parameters
parametersArray containing the parameters to be optimized.
void_instanceA void pointer pointing to the instance of the current class.
ret_tempA matrix to store trace in for gradient for HS test
Returns
Returns with the cost function. (zero if the qubits are desintangled.)
Parameters
parametersArray containing the parameters to be optimized.
void_instanceA void pointer pointing to the instance of the current class.
ret_tempA matrix to store trace in for gradient for HS test
Returns
Returns with the cost function.

Definition at line 822 of file Optimization_Interface.cpp.

Here is the call graph for this function:

◆ optimization_problem() [5/5]

double Optimization_Interface::optimization_problem ( Matrix_real  parameters,
void *  void_instance 
)
static

The optimization problem of the final optimization.

The cost function of the optimization.

Parameters
parametersArray containing the parameters to be optimized.
void_instanceA void pointer pointing to the instance of the current class.
Returns
Returns with the cost function. (zero if the qubits are desintangled.)

Definition at line 920 of file Optimization_Interface.cpp.

Here is the call graph for this function:

◆ optimization_problem_batched()

Matrix_real Optimization_Interface::optimization_problem_batched ( std::vector< Matrix_real > &  parameters_vec)

The cost function of the optimization with batched input (implemented only for the Frobenius norm cost function when run with DFE)

The cost function of the optimization with batched input (implemented only for the Frobenius norm cost function when run with DFE, only state vector simulation if executed on Groq)

Parameters
parametersAn array of the free parameters to be optimized.
Returns
Returns with the cost function values.

Definition at line 732 of file Optimization_Interface.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ optimization_problem_combined() [1/2]

void Optimization_Interface::optimization_problem_combined ( Matrix_real  parameters,
void *  void_instance,
double *  f0,
Matrix_real grad 
)
static

Call to calculate both the cost function and the its gradient components.

Parameters
parametersArray containing the free parameters to be optimized.
void_instanceA void pointer pointing to the instance of the current class.
f0The value of the cost function at x0.
gradArray containing the calculated gradient components.

Definition at line 1186 of file Optimization_Interface.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ optimization_problem_combined() [2/2]

void Optimization_Interface::optimization_problem_combined ( Matrix_real  parameters,
double *  f0,
Matrix_real  grad 
)
virtual

Call to calculate both the cost function and the its gradient components.

Parameters
parametersThe parameters for which the cost fuction shoule be calculated
f0The value of the cost function at x0.
gradAn array storing the calculated gradient components
onlyCPUSet true to use only CPU in the calculations (has effect if compiled to use accelerator devices)
parametersArray containing the free parameters to be optimized.
void_instanceA void pointer pointing to the instance of the current class.
f0The value of the cost function at x0.
gradArray containing the calculated gradient components.

Reimplemented in Variational_Quantum_Eigensolver_Base.

Definition at line 1200 of file Optimization_Interface.cpp.

Here is the call graph for this function:

◆ optimization_problem_combined_non_static()

void Optimization_Interface::optimization_problem_combined_non_static ( Matrix_real  parameters,
void *  void_instance,
double *  f0,
Matrix_real grad 
)
virtual

Call to calculate both the cost function and the its gradient components.

Parameters
parametersArray containing the free parameters to be optimized.
void_instanceA void pointer pointing to the instance of the current class.
f0The value of the cost function at x0.
gradArray containing the calculated gradient components.

Reimplemented in Variational_Quantum_Eigensolver_Base.

Definition at line 958 of file Optimization_Interface.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ optimization_problem_combined_unitary() [1/2]

void Optimization_Interface::optimization_problem_combined_unitary ( Matrix_real  parameters,
void *  void_instance,
Matrix Umtx,
std::vector< Matrix > &  Umtx_deriv 
)
static

Call to calculate both the effect of the circuit on th eunitary and it's gradient componets.

Parameters
parametersArray containing the free parameters to be optimized.
void_instanceA void pointer pointing to the instance of the current class.
UmtxThe unitary on which the circuit is applied in place.
Umtx_derivArray containing the calculated gradient components.

Definition at line 1215 of file Optimization_Interface.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ optimization_problem_combined_unitary() [2/2]

void Optimization_Interface::optimization_problem_combined_unitary ( Matrix_real  parameters,
Matrix Umtx,
std::vector< Matrix > &  Umtx_deriv 
)

Call to calculate both the effect of the circuit on th eunitary and it's gradient componets.

Parameters
parametersArray containing the free parameters to be optimized.
UmtxThe unitary on which the circuit is applied in place.
Umtx_derivArray containing the calculated gradient components.

Definition at line 1262 of file Optimization_Interface.cpp.

Here is the call graph for this function:

◆ optimization_problem_grad()

void Optimization_Interface::optimization_problem_grad ( Matrix_real  parameters,
void *  void_instance,
Matrix_real grad 
)
static

Calculate the derivative of the cost function with respect to the free parameters.

Parameters
parametersArray containing the free parameters to be optimized.
void_instanceA void pointer pointing to the instance of the current class.
gradArray containing the calculated gradient components.

Definition at line 937 of file Optimization_Interface.cpp.

Here is the call graph for this function:

◆ optimization_problem_non_static()

double Optimization_Interface::optimization_problem_non_static ( Matrix_real  parameters,
void *  void_instance 
)
virtual

The optimization problem of the final optimization.

The cost function of the optimization.

Parameters
parametersAn array of the free parameters to be optimized. (The number of teh free paramaters should be equal to the number of parameters in one sub-layer)
Returns
Returns with the cost function. (zero if the qubits are desintangled.)
Parameters
parametersArray containing the parameters to be optimized.
void_instanceA void pointer pointing to the instance of the current class.
Returns
Returns with the cost function. (zero if the qubits are desintangled.)

Reimplemented in Variational_Quantum_Eigensolver_Base.

Definition at line 903 of file Optimization_Interface.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ optimization_problem_panelty()

double Optimization_Interface::optimization_problem_panelty ( double *  parameters,
Gates_block gates_block 
)

The optimization problem of the final optimization.

Parameters
parametersA GNU Scientific Library containing the parameters to be optimized.
void_instanceA void pointer pointing to the instance of the current class.
Returns
Returns with the cost function. (zero if the qubits are desintangled.)

◆ parameters_for_calc_one_qubit()

void Gate::parameters_for_calc_one_qubit ( double &  ThetaOver2,
double &  Phi,
double &  Lambda 
)
virtualinherited

Calculate the matrix of a U3 gate gate corresponding to the given parameters acting on a single qbit space.

Set static values for the angles and constans parameters for calculating the matrix of the gates.

Parameters
ThetaReal parameter standing for the parameter theta.
PhiReal parameter standing for the parameter phi.
LambdaReal parameter standing for the parameter lambda.
Returns
Returns with the matrix of the one-qubit matrix.
Parameters
ThetaOver2Real parameter standing for the parameter theta.
PhiReal parameter standing for the parameter phi.
LambdaReal parameter standing for the parameter lambda.

Reimplemented in RY, RX, RZ, RZ_P, U1, and U2.

Definition at line 767 of file Gate.cpp.

◆ print()

void logging::print ( const std::stringstream &  sstream,
int  verbose_level = 1 
) const
inherited

Call to print output messages in the function of the verbosity level.

Parameters
sstreamThe stringstream input to store the output messages.
verbose_levelInteger input. High level means write more to the standart output, 0 means write nothing. The default value is set to 1.

Definition at line 55 of file logging.cpp.

◆ randomize_parameters()

void Optimization_Interface::randomize_parameters ( Matrix_real input,
Matrix_real output,
const double &  f0 
)

Call to randomize the parameter.

Parameters
inputThe parameters are randomized around the values stores in this array
outputThe randomized parameters are stored within this array
f0weight in the randomiztaion (output = input + rand()*sqrt(f0) ).

Definition at line 468 of file Optimization_Interface.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ release_gate()

void Gates_block::release_gate ( int  idx)
inherited

Call to release one gate in the list.

Definition at line 132 of file Gates_block.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ release_gates()

void Gates_block::release_gates ( )
inherited

Call to release the stored gates.

Definition at line 111 of file Gates_block.cpp.

Here is the caller graph for this function:

◆ reorder_qubits()

void Decomposition_Base::reorder_qubits ( std::vector< int qbit_list)
virtualinherited

Call to reorder the qubits in the matrix of the gate.

Parameters
qbit_listThe reordered list of qubits spanning the matrix

Reimplemented from Gates_block.

Definition at line 732 of file Decomposition_Base.cpp.

Here is the call graph for this function:

◆ reset_dependency_graph()

void Gates_block::reset_dependency_graph ( )
inherited

Method to reset the dependency graph of the gates in the circuit.

Definition at line 2828 of file Gates_block.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ reset_parameter_start_indices()

void Gates_block::reset_parameter_start_indices ( )
inherited

Method to reset the parameter start indices of gate operations incorporated in the circuit.

Method reset the parameter start indices of gate operations incorporated in the circuit.

(When a gate is inserted into the circuit at other position than the end.)

Definition at line 2807 of file Gates_block.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ set_children()

void Gate::set_children ( std::vector< Gate *> &  children_)
inherited

Call to set the children of the current gate.

Parameters
children_the list of the children

Definition at line 802 of file Gate.cpp.

Here is the caller graph for this function:

◆ set_control_qbit()

void Gate::set_control_qbit ( int  control_qbit_in)
inherited

Call to set the control qubit for the gate operation.

Parameters
control_qbit_inThe control qubit. Should be: 0 <= control_qbit_in < qbit_num

Definition at line 308 of file Gate.cpp.

Here is the caller graph for this function:

◆ set_convergence_threshold()

void Decomposition_Base::set_convergence_threshold ( double  convergence_threshold_in)
inherited

Call to set the threshold of convergence in the optimization processes.

Parameters
convergence_threshold_inThe value of the threshold.

Definition at line 861 of file Decomposition_Base.cpp.

◆ set_cost_function_variant()

void Optimization_Interface::set_cost_function_variant ( cost_function_type  variant)

Call to set the variant of the cost function used in the calculations.

Parameters
variantThe variant of the cost function from the enumaration cost_function_type

Definition at line 1286 of file Optimization_Interface.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ set_custom_gate_structure()

void Optimization_Interface::set_custom_gate_structure ( Gates_block gate_structure_in)

Call to set custom layers to the gate structure that are intended to be used in the subdecomposition.

Parameters
gate_structureAn <int, Gates_block*> map containing the gate structure used in the individual subdecomposition (default is used, if a gate structure for specific subdecomposition is missing).

Definition at line 1465 of file Optimization_Interface.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ set_debugfile()

void logging::set_debugfile ( std::string  debugfile)
inherited

Call to set the debugfile name.

Parameters
debugfileString variable. Set the debugfile name.

Definition at line 95 of file logging.cpp.

Here is the caller graph for this function:

◆ set_global_phase()

void Decomposition_Base::set_global_phase ( double  new_global_phase)
inherited

Call to set global phase.

Parameters
global_phase_factor_newThe value of the new phase

Definition at line 929 of file Decomposition_Base.cpp.

Here is the caller graph for this function:

◆ set_iteration_loops() [1/2]

int Decomposition_Base::set_iteration_loops ( int  n,
int  iteration_loops_in 
)
inherited

Set the number of iteration loops during the subdecomposition of the n-th qubit.

Parameters
nThe number of qubits for which number of iteration loops should be used in the subdecomposition.,
iteration_loops_inThe number of iteration loops in each sted of the subdecomposition.
Returns
Returns with 0 if succeded.

Definition at line 791 of file Decomposition_Base.cpp.

Here is the caller graph for this function:

◆ set_iteration_loops() [2/2]

int Decomposition_Base::set_iteration_loops ( std::map< int, int iteration_loops_in)
inherited

Set the number of iteration loops during the subdecomposition of the qbit-th qubit.

Parameters
iteration_loops_inAn <int,int> map containing the number of iteration loops for the individual subdecomposition processes
Returns
Returns with 0 if succeded.

Definition at line 811 of file Decomposition_Base.cpp.

Here is the call graph for this function:

◆ set_matrix()

void Gate::set_matrix ( Matrix  input)
inherited

Call to set the stored matrix in the operation.

Parameters
inputThe operation matrix to be stored. The matrix is stored by attribute matrix_alloc.
Returns
Returns with 0 on success.

Definition at line 299 of file Gate.cpp.

Here is the caller graph for this function:

◆ set_max_inner_iterations()

void Optimization_Interface::set_max_inner_iterations ( int  max_inner_iterations_in)

Call to set the maximal number of iterations for which an optimization engine tries to solve the optimization problem.

Call to set the number of iterations for which an optimization engine tries to solve the optimization problem.

Parameters
max_inner_iterations_inThe number of iterations for which an optimization engine tries to solve the optimization problem

Definition at line 1303 of file Optimization_Interface.cpp.

Here is the caller graph for this function:

◆ set_max_iteration()

void Decomposition_Base::set_max_iteration ( int  max_outer_iterations_in)
inherited

Call to set the maximal number of the iterations in the optimization process.

Parameters
max_outer_iterations_inmaximal number of iteartions in the optimization process

Definition at line 230 of file Decomposition_Base.cpp.

Here is the caller graph for this function:

◆ set_max_layer_num() [1/2]

int Decomposition_Base::set_max_layer_num ( int  n,
int  max_layer_num_in 
)
inherited

Set the maximal number of layers used in the subdecomposition of the n-th qubit.

Parameters
nThe number of qubits for which the maximal number of layers should be used in the subdecomposition.
max_layer_num_inThe maximal number of the gate layers used in the subdecomposition.
Returns
Returns with 0 if succeded.

Definition at line 696 of file Decomposition_Base.cpp.

Here is the caller graph for this function:

◆ set_max_layer_num() [2/2]

int Decomposition_Base::set_max_layer_num ( std::map< int, int max_layer_num_in)
inherited

Set the maximal number of layers used in the subdecomposition of the n-th qubit.

Parameters
max_layer_num_inAn <int,int> map containing the maximal number of the gate layers used in the subdecomposition.
Returns
Returns with 0 if succeded.

Definition at line 716 of file Decomposition_Base.cpp.

Here is the call graph for this function:

◆ set_optimization_blocks()

void Decomposition_Base::set_optimization_blocks ( int  optimization_block_in)
inherited

Call to set the number of gate blocks to be optimized in one shot.

Parameters
optimization_block_inThe number of gate blocks to be optimized in one shot

Definition at line 222 of file Decomposition_Base.cpp.

Here is the caller graph for this function:

◆ set_optimization_tolerance()

void Decomposition_Base::set_optimization_tolerance ( double  tolerance_in)
inherited

Call to set the tolerance of the optimization processes.

Parameters
tolerance_inThe value of the tolerance.
tolerance_inThe value of the tolerance. The error of the decomposition would scale with the square root of this value.

Definition at line 849 of file Decomposition_Base.cpp.

Here is the caller graph for this function:

◆ set_optimized_parameters()

void Decomposition_Base::set_optimized_parameters ( double *  parameters,
int  num_of_parameters 
)
inherited

Call to set the optimized parameters for initial optimization.

Parameters
retPreallocated array to store the optimized parameters.

Definition at line 643 of file Decomposition_Base.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ set_optimizer()

void Optimization_Interface::set_optimizer ( optimization_aglorithms  alg_in)

Call to set the optimizer engine to be used in solving the optimization problem.

Parameters
alg_inThe chosen algorithm

Definition at line 1326 of file Optimization_Interface.cpp.

Here is the caller graph for this function:

◆ set_parameter_start_idx()

void Gate::set_parameter_start_idx ( int  start_idx)
inherited

Call to set the starting index of the parameters in the parameter array corresponding to the circuit in which the current gate is incorporated.

Parameters
start_idxThe starting index

Definition at line 779 of file Gate.cpp.

Here is the caller graph for this function:

◆ set_parents()

void Gate::set_parents ( std::vector< Gate *> &  parents_)
inherited

Call to set the parents of the current gate.

Parameters
parents_the list of the parents

Definition at line 790 of file Gate.cpp.

Here is the caller graph for this function:

◆ set_project_name()

void Decomposition_Base::set_project_name ( std::string &  project_name_new)
inherited

Call to set the name of the project.

Parameters
project_name_newpointer to the new project name

Definition at line 902 of file Decomposition_Base.cpp.

Here is the caller graph for this function:

◆ set_qbit_num()

void Decomposition_Base::set_qbit_num ( int  qbit_num_in)
virtualinherited

Set the number of qubits spanning the matrix of the gates stored in the block of gates.

Parameters
qbit_num_inThe number of qubits spanning the matrices.

Reimplemented from Gates_block.

Definition at line 1039 of file Decomposition_Base.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ set_random_shift_count_max()

void Optimization_Interface::set_random_shift_count_max ( int  random_shift_count_max_in)

Call to set the maximal number of parameter randomization tries to escape a local minimum.

Parameters
random_shift_count_max_inThe number of maximal number of parameter randomization tries to escape a local minimum.

Definition at line 1315 of file Optimization_Interface.cpp.

Here is the caller graph for this function:

◆ set_target_qbit()

void Gate::set_target_qbit ( int  target_qbit_in)
inherited

Call to set the target qubit for the gate operation.

Parameters
target_qbit_inThe target qubit on which the gate is applied. Should be: 0 <= target_qbit_in < qbit_num

Definition at line 324 of file Gate.cpp.

Here is the caller graph for this function:

◆ set_trace_offset()

void Optimization_Interface::set_trace_offset ( int  trace_offset_in)

Set the trace offset used in the evaluation of the cost function.

Definition at line 1491 of file Optimization_Interface.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ set_verbose()

void logging::set_verbose ( int  verbose_in)
inherited

Call to set the verbose attribute.

Parameters
verbose_inInteger variable. Set the number to specify the verbosity level for output messages.

Definition at line 85 of file logging.cpp.

Here is the caller graph for this function:

◆ solve_layer_optimization_problem()

void Optimization_Interface::solve_layer_optimization_problem ( int  num_of_parameters,
Matrix_real  solution_guess 
)
virtual

Call to solve layer by layer the optimization problem via calling one of the implemented algorithms.

The optimalized parameters are stored in attribute optimized_parameters.

Parameters
num_of_parametersNumber of parameters to be optimized
solution_guessArray containing the solution guess.

Reimplemented from Decomposition_Base.

Definition at line 417 of file Optimization_Interface.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ solve_layer_optimization_problem_ADAM()

void Optimization_Interface::solve_layer_optimization_problem_ADAM ( int  num_of_parameters,
Matrix_real solution_guess 
)

Call to solve layer by layer the optimization problem via ADAM algorithm.

(optimal for larger problems) The optimalized parameters are stored in attribute optimized_parameters.

Parameters
num_of_parametersNumber of parameters to be optimized
solution_guessA matrix containing the solution guess.

(optimal for larger problems) The optimalized parameters are stored in attribute optimized_parameters.

Parameters
num_of_parametersNumber of parameters to be optimized
solution_guessArray containing the solution guess.

Definition at line 44 of file optimization_engines/Adam.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ solve_layer_optimization_problem_ADAM_BATCHED()

void Optimization_Interface::solve_layer_optimization_problem_ADAM_BATCHED ( int  num_of_parameters,
Matrix_real solution_guess 
)

Call to solve layer by layer the optimization problem via batched ADAM algorithm.

(optimal for larger problems) The optimalized parameters are stored in attribute optimized_parameters.

Parameters
num_of_parametersNumber of parameters to be optimized
solution_guessA matrix containing the solution guess.

(optimal for larger problems) The optimalized parameters are stored in attribute optimized_parameters.

Parameters
num_of_parametersNumber of parameters to be optimized
solution_guessArray containing the solution guess.

Definition at line 44 of file ADAM_BATCHED.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ solve_layer_optimization_problem_AGENTS()

void Optimization_Interface::solve_layer_optimization_problem_AGENTS ( int  num_of_parameters,
Matrix_real solution_guess 
)

Call to solve layer by layer the optimization problem via the AGENT algorithm.

The optimalized parameters are stored in attribute optimized_parameters.

Parameters
num_of_parametersNumber of parameters to be optimized
solution_guessA matrix containing the solution guess.

The optimalized parameters are stored in attribute optimized_parameters.

Parameters
num_of_parametersNumber of parameters to be optimized
solution_guessArray containing the solution guess.

Definition at line 42 of file AGENTS.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ solve_layer_optimization_problem_AGENTS_COMBINED()

void Optimization_Interface::solve_layer_optimization_problem_AGENTS_COMBINED ( int  num_of_parameters,
Matrix_real solution_guess 
)

Call to solve layer by layer the optimization problem via the AGENT COMBINED algorithm.

The optimalized parameters are stored in attribute optimized_parameters.

Parameters
num_of_parametersNumber of parameters to be optimized
solution_guessA matrix containing the solution guess.

The optimalized parameters are stored in attribute optimized_parameters.

Parameters
num_of_parametersNumber of parameters to be optimized
solution_guessArray containing the solution guess.

Definition at line 920 of file AGENTS.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ solve_layer_optimization_problem_BAYES_AGENTS()

void Optimization_Interface::solve_layer_optimization_problem_BAYES_AGENTS ( int  num_of_parameters,
Matrix_real solution_guess 
)

Call to solve layer by layer the optimization problem via Bayes & Agents algorithm.

The optimalized parameters are stored in attribute optimized_parameters.

Parameters
num_of_parametersNumber of parameters to be optimized
solution_guessA matrix containing the solution guess.

Definition at line 40 of file BAYES_AGENTS.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ solve_layer_optimization_problem_BAYES_OPT()

void Optimization_Interface::solve_layer_optimization_problem_BAYES_OPT ( int  num_of_parameters,
Matrix_real solution_guess 
)

Call to solve layer by layer the optimization problem via Bayes algorithm.

Call to solve layer by layer the optimization problem via BBFG algorithm.

The optimalized parameters are stored in attribute optimized_parameters.

Parameters
num_of_parametersNumber of parameters to be optimized
solution_guessA matrix containing the solution guess.

(optimal for smaller problems) The optimalized parameters are stored in attribute optimized_parameters.

Parameters
num_of_parametersNumber of parameters to be optimized
solution_guessArray containing the solution guess.

Definition at line 44 of file optimization_engines/Bayes_Opt.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ solve_layer_optimization_problem_BFGS()

void Optimization_Interface::solve_layer_optimization_problem_BFGS ( int  num_of_parameters,
Matrix_real solution_guess 
)

Call to solve layer by layer the optimization problem via BBFG algorithm.

(optimal for smaller problems) The optimalized parameters are stored in attribute optimized_parameters.

Parameters
num_of_parametersNumber of parameters to be optimized
solution_guessA matrix containing the solution guess.

(optimal for smaller problems) The optimalized parameters are stored in attribute optimized_parameters.

Parameters
num_of_parametersNumber of parameters to be optimized
solution_guessArray containing the solution guess.

Definition at line 42 of file BFGS.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ solve_layer_optimization_problem_BFGS2()

void Optimization_Interface::solve_layer_optimization_problem_BFGS2 ( int  num_of_parameters,
Matrix_real  solution_guess 
)

Call to solve layer by layer the optimization problem via BBFG algorithm.

Call to solve layer by layer the optimization problem via BFGS algorithm.

The optimalized parameters are stored in attribute optimized_parameters.

Parameters
num_of_parametersNumber of parameters to be optimized
solution_guessA matrix containing the solution guess.

The optimalized parameters are stored in attribute optimized_parameters.

Parameters
num_of_parametersNumber of parameters to be optimized
solution_guess_gslA GNU Scientific Library vector containing the solution guess.

Definition at line 42 of file BFGS2.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ solve_layer_optimization_problem_COSINE()

void Optimization_Interface::solve_layer_optimization_problem_COSINE ( int  num_of_parameters,
Matrix_real solution_guess 
)

Call to solve layer by layer the optimization problem via the COSINE algorithm.

The optimalized parameters are stored in attribute optimized_parameters.

Parameters
num_of_parametersNumber of parameters to be optimized
solution_guessA matrix containing the solution guess.

The optimalized parameters are stored in attribute optimized_parameters.

Parameters
num_of_parametersNumber of parameters to be optimized
solution_guessArray containing the solution guess.

Definition at line 43 of file COSINE.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ solve_layer_optimization_problem_GRAD_DESCEND()

void Optimization_Interface::solve_layer_optimization_problem_GRAD_DESCEND ( int  num_of_parameters,
Matrix_real solution_guess 
)

Call to solve layer by layer the optimization problem via the GRAD_DESCEND (line search in the direction determined by the gradient) algorithm.

The optimalized parameters are stored in attribute optimized_parameters.

Parameters
num_of_parametersNumber of parameters to be optimized
solution_guessA matrix containing the solution guess.

The optimalized parameters are stored in attribute optimized_parameters.

Parameters
num_of_parametersNumber of parameters to be optimized
solution_guess_gslA GNU Scientific Library vector containing the solution guess.

Definition at line 44 of file optimization_engines/grad_descend.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ solve_layer_optimization_problem_GRAD_DESCEND_PARAMETER_SHIFT_RULE()

void Optimization_Interface::solve_layer_optimization_problem_GRAD_DESCEND_PARAMETER_SHIFT_RULE ( int  num_of_parameters,
Matrix_real solution_guess 
)

Call to solve layer by layer the optimization problem via the GRAD_DESCEND_PARAMETER_SHIFT_RULE algorithm.

The optimalized parameters are stored in attribute optimized_parameters.

Parameters
num_of_parametersNumber of parameters to be optimized
solution_guessA matrix containing the solution guess.

The optimalized parameters are stored in attribute optimized_parameters.

Parameters
num_of_parametersNumber of parameters to be optimized
solution_guessArray containing the solution guess.

Definition at line 41 of file GRAD_DESCEND_PARAMETER_SHIFT_RULE.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ solve_optimization_problem()

void Decomposition_Base::solve_optimization_problem ( double *  solution_guess,
int  solution_guess_num 
)
inherited

This method can be used to solve the main optimization problem which is devidid into sub-layer optimization processes.

This method can be used to solve the main optimization problem which is divided into sub-layer optimization processes.

(The aim of the optimization problem is to disentangle one or more qubits) The optimalized parameters are stored in attribute optimized_parameters.

Parameters
solution_guessAn array of the guessed parameters
solution_guess_numThe number of guessed parameters. (not necessarily equal to the number of free parameters)

Definition at line 256 of file Decomposition_Base.cpp.

Here is the call graph for this function:
Here is the caller graph for this function:

Member Data Documentation

◆ accelerator_num

int Optimization_Interface::accelerator_num
protected

number of utilized accelerators

Definition at line 126 of file Optimization_Interface.h.

◆ adaptive_eta

bool Optimization_Interface::adaptive_eta
protected

logical variable indicating whether adaptive learning reate is used in the ADAM algorithm

Definition at line 120 of file Optimization_Interface.h.

◆ alg

optimization_aglorithms Optimization_Interface::alg
protected

The optimization algorithm to be used in the optimization.

Definition at line 105 of file Optimization_Interface.h.

◆ block_end

std::vector<int> Gates_block::block_end
protectedinherited

Definition at line 59 of file Gates_block.h.

◆ block_type

std::vector<int> Gates_block::block_type
protectedinherited

Definition at line 60 of file Gates_block.h.

◆ children

std::vector<Gate*> Gate::children
protectedinherited

list of child gates to be applied after this current gate

Definition at line 97 of file Gate.h.

◆ circuit_simulation_time

double Optimization_Interface::circuit_simulation_time
protected

Time spent on circuit simulation/cost function evaluation.

Definition at line 133 of file Optimization_Interface.h.

◆ config

std::map<std::string, Config_Element> Decomposition_Base::config
inherited

config metadata utilized during the optimization

Definition at line 108 of file Decomposition_Base.h.

◆ control_qbit

int Gate::control_qbit
protectedinherited

The index of the qubit which acts as a control qubit (control_qbit >= 0) in controlled operations.

Definition at line 87 of file Gate.h.

◆ convergence_threshold

double Decomposition_Base::convergence_threshold
protectedinherited

The convergence threshold in the optimization process.

Definition at line 159 of file Decomposition_Base.h.

◆ correction1_scale

double Optimization_Interface::correction1_scale
protected

prefactor of the single-bitflip errors in the cost function. (see Eq. (21) in arXiv:2210.09191)

Definition at line 111 of file Optimization_Interface.h.

◆ correction2_scale

double Optimization_Interface::correction2_scale
protected

prefactor of the double-bitflip errors in the cost function. (see Eq. (21) in arXiv:2210.09191)

Definition at line 113 of file Optimization_Interface.h.

◆ cost_fnc

cost_function_type Optimization_Interface::cost_fnc
protected

The chosen variant of the cost function.

Definition at line 107 of file Optimization_Interface.h.

◆ CPU_time

double Optimization_Interface::CPU_time
protected

time spent on optimization

Definition at line 135 of file Optimization_Interface.h.

◆ current_minimum

double Decomposition_Base::current_minimum
protectedinherited

The current minimum of the optimization problem.

Definition at line 141 of file Decomposition_Base.h.

◆ debug

bool logging::debug
inherited

Logical variable. Set true to write output messages to the 'debug.txt' file.

Definition at line 53 of file logging.h.

◆ debugfile_name

std::string logging::debugfile_name
inherited

String variable. Set the debug file name.

Definition at line 56 of file logging.h.

◆ decomposition_error

double Decomposition_Base::decomposition_error
protectedinherited

error of the final decomposition

Definition at line 132 of file Decomposition_Base.h.

◆ decomposition_finalized

bool Decomposition_Base::decomposition_finalized
protectedinherited

The optimized parameters for the gates.

logical value describing whether the decomposition was finalized or not (i.e. whether the decomposed qubits were rotated into the state |0> or not)

Definition at line 129 of file Decomposition_Base.h.

◆ finalizing_gates_num

int Decomposition_Base::finalizing_gates_num
protectedinherited

number of finalizing (deterministic) opertaions rotating the disentangled qubits into state |0>.

Definition at line 135 of file Decomposition_Base.h.

◆ finalizing_parameter_num

int Decomposition_Base::finalizing_parameter_num
protectedinherited

the number of the finalizing (deterministic) parameters of gates rotating the disentangled qubits into state |0>.

Definition at line 138 of file Decomposition_Base.h.

◆ fragmentation_type

int Gates_block::fragmentation_type
protectedinherited

Definition at line 55 of file Gates_block.h.

◆ fragmented

bool Gates_block::fragmented
protectedinherited

boolean variable indicating whether the circuit was already partitioned or not

Definition at line 54 of file Gates_block.h.

◆ gates

std::vector<Gate*> Gates_block::gates
protectedinherited

The list of stored gates.

Definition at line 46 of file Gates_block.h.

◆ gen

std::mt19937 Decomposition_Base::gen
protectedinherited

Standard mersenne_twister_engine seeded with rd()

Definition at line 163 of file Decomposition_Base.h.

◆ global_phase_factor

QGD_Complex16 Decomposition_Base::global_phase_factor
inherited

The global phase.

Definition at line 102 of file Decomposition_Base.h.

◆ global_target_minimum

double Decomposition_Base::global_target_minimum
protectedinherited

The global target minimum of the optimization problem.

Definition at line 144 of file Decomposition_Base.h.

◆ id

int Optimization_Interface::id

unique id indentifying the instance of the class

Definition at line 95 of file Optimization_Interface.h.

◆ identical_blocks

std::map<int,int> Optimization_Interface::identical_blocks
protected

A map of <int n: int num> indicating that how many identical successive blocks should be used in the disentanglement of the nth qubit from the others.

Definition at line 103 of file Optimization_Interface.h.

◆ initial_guess

guess_type Decomposition_Base::initial_guess
protectedinherited

type to guess the initial values for the optimization. Possible values: ZEROS=0, RANDOM=1, CLOSE_TO_ZERO=2

Definition at line 153 of file Decomposition_Base.h.

◆ involved_qbits

std::vector< std::vector<int> > Gates_block::involved_qbits
protectedinherited

Definition at line 58 of file Gates_block.h.

◆ iteration_loops

std::map<int,int> Decomposition_Base::iteration_loops
protectedinherited

A map of <int n: int num> indicating the number of iteration in each step of the decomposition.

Definition at line 117 of file Decomposition_Base.h.

◆ layer_num

int Gates_block::layer_num
protectedinherited

number of gate layers

Definition at line 48 of file Gates_block.h.

◆ matrix_size

int Gate::matrix_size
protectedinherited

The size N of the NxN matrix associated with the operations.

Definition at line 89 of file Gate.h.

◆ max_fusion

int Gates_block::max_fusion
protectedinherited

maximal number of qubits in partitions

Definition at line 57 of file Gates_block.h.

◆ max_inner_iterations

int Optimization_Interface::max_inner_iterations

the maximal number of iterations for which an optimization engine tries to solve the optimization problem

Definition at line 91 of file Optimization_Interface.h.

◆ max_layer_num

std::map<int,int> Decomposition_Base::max_layer_num
protectedinherited

A map of <int n: int num> indicating that how many layers should be used in the subdecomposition process for the subdecomposing of the nth qubits.

Definition at line 114 of file Decomposition_Base.h.

◆ max_layer_num_def

std::map< int, int > Decomposition_Base::max_layer_num_def
staticinherited

A map of <int n: int num> indicating that how many layers should be used in the subdecomposition process by default for the subdecomposing of the nth qubits.

Definition at line 96 of file Decomposition_Base.h.

◆ max_outer_iterations

int Decomposition_Base::max_outer_iterations
protectedinherited

Maximal number of iterations allowed in the optimization process.

Definition at line 150 of file Decomposition_Base.h.

◆ name

std::string Gate::name
protectedinherited

A string labeling the gate operation.

Definition at line 79 of file Gate.h.

◆ num_threads

int Decomposition_Base::num_threads
protectedinherited

Store the number of OpenMP threads. (During the calculations OpenMP multithreading is turned off.)

Definition at line 156 of file Decomposition_Base.h.

◆ number_of_iters

int Optimization_Interface::number_of_iters
protected

number of iterations

Definition at line 117 of file Optimization_Interface.h.

◆ optimization_block

int Decomposition_Base::optimization_block
inherited

number of gate blocks used in one shot of the optimization process

Definition at line 93 of file Decomposition_Base.h.

◆ optimization_problem_solved

bool Decomposition_Base::optimization_problem_solved
protectedinherited

logical value describing whether the optimization problem was solved or not

Definition at line 147 of file Decomposition_Base.h.

◆ optimization_tolerance

double Decomposition_Base::optimization_tolerance
inherited

The maximal allowed error of the optimization problem (The error of the decomposition would scale with the square root of this value)

Definition at line 99 of file Decomposition_Base.h.

◆ optimize_layer_num

bool Optimization_Interface::optimize_layer_num
protected

logical value. Set true to optimize the minimum number of gate layers required in the decomposition, or false when the predefined maximal number of layer gates is used (ideal for general unitaries).

Definition at line 100 of file Optimization_Interface.h.

◆ optimized_parameters_mtx

Matrix_real Decomposition_Base::optimized_parameters_mtx
protectedinherited

The optimized parameters for the gates.

Definition at line 123 of file Decomposition_Base.h.

◆ parameter_num

int Gate::parameter_num
protectedinherited

the number of free parameters of the operation

Definition at line 91 of file Gate.h.

◆ parameter_start_idx

int Gate::parameter_start_idx
protectedinherited

the index in the parameter array (corrensponding to the encapsulated circuit) where the gate parameters begin (if gates are placed into a circuit a single parameter array is used to execute the whole circuit)

Definition at line 93 of file Gate.h.

◆ parents

std::vector<Gate*> Gate::parents
protectedinherited

list of parent gates to be applied in the circuit prior to this current gate

Definition at line 95 of file Gate.h.

◆ prev_cost_fnv_val

double Optimization_Interface::prev_cost_fnv_val
protected

the previous value of the cost funtion to be used to evaluate bitflip errors in the cost funtion (see Eq. (21) in arXiv:2210.09191)

Definition at line 109 of file Optimization_Interface.h.

◆ project_name

std::string Decomposition_Base::project_name
inherited

the name of the project

Definition at line 105 of file Decomposition_Base.h.

◆ qbit_num

int Gate::qbit_num
protectedinherited

number of qubits spanning the matrix of the operation

Definition at line 81 of file Gate.h.

◆ radius

double Optimization_Interface::radius
protected

parameter to contron the radius of parameter randomization around the curren tminimum

Definition at line 122 of file Optimization_Interface.h.

◆ random_shift_count_max

int Optimization_Interface::random_shift_count_max

the maximal number of parameter randomization tries to escape a local minimum.

Definition at line 93 of file Optimization_Interface.h.

◆ randomization_rate

double Optimization_Interface::randomization_rate
protected

randomization rate

Definition at line 124 of file Optimization_Interface.h.

◆ target_qbit

int Gate::target_qbit
protectedinherited

The index of the qubit on which the operation acts (target_qbit >= 0)

Definition at line 85 of file Gate.h.

◆ trace_offset

int Optimization_Interface::trace_offset
protected

The offset in the first columns from which the "trace" is calculated. In this case Tr(A) = sum_(i-offset=j) A_{ij}.

Definition at line 129 of file Optimization_Interface.h.

◆ type

gate_type Gate::type
protectedinherited

The type of the operation (see enumeration gate_type)

Definition at line 83 of file Gate.h.

◆ Umtx

Matrix Decomposition_Base::Umtx
protectedinherited

The unitary to be decomposed.

Definition at line 120 of file Decomposition_Base.h.

◆ verbose

int logging::verbose
inherited

Set the verbosity level of the output messages.

Definition at line 50 of file logging.h.


The documentation for this class was generated from the following files: