Skip to content
Snippets Groups Projects
Commit a05c1422 authored by Donjan Rodic's avatar Donjan Rodic
Browse files

Added exercise 12

parent aba69d93
No related branches found
No related tags found
No related merge requests found
CXX_FLAGS ?= -DNDEBUG -O2
all: sim_thermal_annealing sim_quantum_annealing
run_quantum:
./sim_quantum_annealing 2> succ_rates-quantum.txt
./plot_succ_rates.py
run_thermal:
./sim_thermal_annealing > output-thermal.txt
sim_thermal_annealing: sim_thermal_annealer.hpp sim_thermal.cpp
$(CXX) $(CXX_FLAGS) sim_thermal.cpp -o sim_thermal_annealing
sim_quantum_annealing: sim_quantum_annealer.hpp sim_quantum.cpp
$(CXX) $(CXX_FLAGS) sim_quantum.cpp -o sim_quantum_annealing
clean:
-rm sim_thermal_annealing
-rm sim_quantum_annealing
-136 10 1 1 -1 1 1 -1 -1 1 1 1 -1 1 1 -1 1 -1 -1 1 1 1 1 -1 1 1 1 1 1 -1 1 -1 1 -1 -1 -1 -1 1 1 -1 1 -1 -1 -1 1 1 -1 -1 -1 1 1 1 -1 1 1 -1 -1 -1 1 -1 1 -1 1 -1 1 1 1 1 1 -1 -1 -1 1 -1 1 -1 1 -1 -1 -1 1 -1 -1 1 1 1 1 -1 1 1 -1 1 -1 -1 1 1 1 -1 1 -1 -1 -1 -1 1 1 -1 -1 1 -1 1 1 1 1 1 -1 1 -1 -1 -1 1 1 1 1 -1 -1 1 -1 1 -1 -1 -1 -1 1 -1 1 -1 1 1 -1 1 -1 1 -1 -1 -1 -1 -1 -1 -1 1 1 1 1 -1 1 1 -1 1 1 1 1 -1 1 1 1 -1 -1 1 -1 1 -1 1 1 -1 -1 -1 -1 1 1 1 1 1 -1 1 1 1 1 1 -1 1 -1 1 -1 -1 1 -1 1 -1 -1 -1 1 -1
#include <iostream>
#include <fstream>
#include <stdexcept>
#include "sim_quantum_annealer.hpp"
void load(std::string const& filename, std::size_t& N, int& exact_energy, std::vector<short>& row_couplings, std::vector<short>& col_couplings) {
std::ifstream in(filename.c_str());
in >> exact_energy;
in >> N;
row_couplings.resize(N*N);
col_couplings.resize(N*N);
for(std::size_t i=0; i < N*N; ++i)
in >> row_couplings[i];
for(std::size_t i=0; i < N*N; ++i)
in >> col_couplings[i];
}
int main() {
int const copies = 1000;
int exact_energy = 0.0;
std::size_t N = 10;
std::vector<short> row_couplings;
std::vector<short> col_couplings;
load("instance.txt", N, exact_energy, row_couplings, col_couplings);
for(double beta=4e-2; beta <= 11; beta *= 2)
for(double dt=1e-5; dt <= 1e-1 ; dt *= 10) {
int minimum = 0;
int gs_hits = 0;
for(int i = 0 ; i < copies; ++i) {
cqp::quantum_annealer annealer(N,row_couplings, col_couplings, 10, 23*i);
annealer.run(beta, dt); {
std::cout <<"Run " << i <<": E = " <<annealer.energy() << std::endl;
minimum = (std::min)(minimum,annealer.energy());
if(annealer.energy() == exact_energy)
++gs_hits;
}
}
double rate = static_cast<double>(gs_hits) / copies;
double err = std::sqrt((static_cast<double>(gs_hits) / copies - rate*rate)/(copies-1));
std::cout<<"exact E = "<< exact_energy <<std::endl;
std::cout<<"annealing min E = "<< minimum << std::endl;
std::cout<<"%: "<< rate << "+/-" << err << std::endl;
std::cerr<<"beta = " << beta << " dt = " << dt << " rate = "<< rate << " +/- " << err<< std::endl;
}
return 0;
}
#ifndef SIM_QUANTUM_ANNEALER_HPP
#define SIM_QUANTUM_ANNEALER_HPP
#include <vector>
#include <limits>
#include <random>
#include <assert.h>
namespace cqp {
class quantum_annealer {
public:
typedef int energy_t;
quantum_annealer(std::size_t N, std::vector<short> const& row_c, std::vector<short> const& col_c, std::size_t M, unsigned int seed = 3000)
: rng(seed), random_site(0,N-1), random_time_slice(0,M-1), row_c(row_c), col_c(col_c), spin_rows(N*M), N(N), M(M) {
// We also assume row_c and col_c have only +1,-1 elements
assert(N < 64);
init();
}
void init() {
// Generate random spin config
for(std::size_t i = 0; i < spin_rows.size(); ++i) {
spin_rows[i] = rng();
spin_rows[i] <<= 32;
spin_rows[i] |= rng();
}
}
// +1 if spins are antialigned, -1 if spins are aligned
inline int64_t get_sign( /* TODO */ ) const {
/* TODO */
return 0;
}
void sweep(double beta, double alpha, double field) {
double delta = beta / M;
double j_t = std::numeric_limits<double>::max(); // limit of the coupling strength as gamma ->0 (all the replicas are perfectly coupled)
/* TODO */
}
energy_t energy() const {
energy_t e = 0;
/* TODO */
return e;
}
void run(double beta, double delta_t) {
init();
for(double t=0; t <= 1.0; t += delta_t) {
/* TODO */
}
}
private:
std::mt19937 rng;
std::uniform_real_distribution<> rnd;
std::uniform_int_distribution<> random_site;
std::uniform_int_distribution<> random_time_slice;
std::vector<short> const row_c;
std::vector<short> const col_c;
std::vector<uint64_t> spin_rows;
std::size_t const N;
std::size_t const M;
};
}
#endif //SIM_QUANTUM_ANNEALER_HPP
#include <iostream>
#include <fstream>
#include <stdexcept>
#include "sim_thermal_annealer.hpp"
void load(std::string const& filename, std::size_t& N, int& exact_energy, std::vector<short>& row_couplings, std::vector<short>& col_couplings) {
std::ifstream in(filename.c_str());
in >> exact_energy;
in >> N;
row_couplings.resize(N*N);
col_couplings.resize(N*N);
for(std::size_t i=0; i < N*N; ++i)
in >> row_couplings[i];
for(std::size_t i=0; i < N*N; ++i)
in >> col_couplings[i];
}
int main() {
int minimum = 0;
int const copies = 100;
int gs_hits = 0;
int exact_energy = 0.0;
std::size_t N = 10;
std::vector<short> row_couplings;
std::vector<short> col_couplings;
load("instance.txt", N, exact_energy, row_couplings, col_couplings);
cqp::thermal_annealer annealer(N,row_couplings, col_couplings);
for(int i = 0 ; i < copies; ++i) {
annealer.run(1e-5, 0.1, 5.0);
std::cout <<"Run " << i <<": E = " <<annealer.energy() << std::endl;
minimum = (std::min)(minimum,annealer.energy());
if(annealer.energy() == exact_energy)
++gs_hits;
}
std::cout<<"exact E = "<< exact_energy <<std::endl;
std::cout<<"annealing min E = "<< minimum << std::endl;
std::cout<<"%: "<< static_cast<double>(gs_hits)/copies << std::endl;
return 0;
}
File added
#ifndef SIM_THERMAL_ANNEALER_HPP
#define SIM_THERMAL_ANNEALER_HPP
#include <vector>
#include <random>
#include <assert.h>
namespace cqp {
class thermal_annealer {
public:
typedef int energy_t;
thermal_annealer(std::size_t N, std::vector<short> const& row_c, std::vector<short> const& col_c, unsigned int seed = 5000)
: rng(seed), random_site(0,N-1), row_c(row_c), col_c(col_c), spin_rows(N), N(N) {
// We also assume row_c and col_c have only +1,-1 elements
assert(N < 64);
init();
}
void init() {
// Generate random spin config
for(std::size_t i = 0; i < N; ++i) {
spin_rows[i] = rng();
spin_rows[i] <<= 32;
spin_rows[i] |= rng();
}
}
inline int64_t get_sign( /* TODO */ ) const {
/* TODO */
return 0;
}
void sweep(double beta) {
/* TODO */
}
energy_t energy() const {
energy_t e = 0;
/* TODO */
return e;
}
void run(double delta_beta, double beta = 1e-5, double beta_max = 5.0) {
init();
for(; beta < beta_max; beta += delta_beta)
sweep(beta);
}
private:
std::mt19937 rng;
std::uniform_real_distribution<> rnd;
std::uniform_int_distribution<> random_site;
std::vector<short> const row_c;
std::vector<short> const col_c;
std::vector<uint64_t> spin_rows;
std::size_t const N;
};
}
#endif //SIM_THERMAL_ANNEALER_HPP
File added
0% Loading or .
You are about to add 0 people to the discussion. Proceed with caution.
Finish editing this message first!
Please register or to comment