Newer
Older

Michal Kravcenko
committed
/**
* DESCRIPTION OF THE FILE
*
* @author Michal Kravčenko
* @date 2.7.18 -
*/

Michal Kravcenko
committed
#include <iostream>

Michal Kravcenko
committed
#include "ParticleSwarm.h"
/**
* TODO
* domain_bound out_of_range check
* @param f_dim
* @param domain_bounds
* @param F
*/

Michal Kravcenko
committed

Michal Kravcenko
committed
void Particle::randomize_coordinates() {

Michal Kravcenko
committed
std::random_device seeder;
std::mt19937 gen(seeder());

Michal Kravcenko
committed
std::uniform_real_distribution<double> dist_coord(-1.0, 1.0);
this->domain_bounds = domain_bounds;
for(unsigned int i = 0; i < this->coordinate_dim; ++i){

Michal Kravcenko
committed
(*this->coordinate)[i] = dist_coord(gen);

Michal Kravcenko
committed
}

Michal Kravcenko
committed
}
void Particle::randomize_parameters() {

Michal Kravcenko
committed

Michal Kravcenko
committed
std::random_device seeder;
std::mt19937 gen(seeder());
std::uniform_real_distribution<double> dist_vel(0.5, 1.0);
this->r1 = dist_vel(gen);
this->r2 = dist_vel(gen);
this->r3 = dist_vel(gen);

Michal Kravcenko
committed
}

Michal Kravcenko
committed
void Particle::randomize_velocity() {
std::random_device seeder;
std::mt19937 gen(seeder());
std::uniform_real_distribution<double> dist_vel(0.5, 1.0);
for(unsigned int i = 0; i < this->coordinate_dim; ++i){
(*this->velocity)[i] = dist_vel(gen);
}
}

Michal Kravcenko
committed

Michal Kravcenko
committed
Particle::Particle(ErrorFunction* ef, double *domain_bounds) {
//TODO better generating of random numbers

Michal Kravcenko
committed
this->domain_bounds = domain_bounds;

Michal Kravcenko
committed
this->coordinate_dim = ef->get_dimension();
this->ef = ef;
this->coordinate = new std::vector<double>(this->coordinate_dim);
this->velocity = new std::vector<double>(this->coordinate_dim);
this->optimal_coordinate = new std::vector<double>(this->coordinate_dim);
this->randomize_velocity();
this->randomize_parameters();
this->randomize_coordinates();
for(unsigned int i = 0; i < this->coordinate_dim; ++i){
(*this->optimal_coordinate)[i] = (*this->coordinate)[i];

Michal Kravcenko
committed
}
this->optimal_value = this->ef->eval(this->coordinate);

Michal Kravcenko
committed

Michal Kravcenko
committed
this->print_coordinate();

Michal Kravcenko
committed
}
Particle::~Particle() {
if( this->optimal_coordinate ){

Michal Kravcenko
committed
}
if( this->coordinate ){

Michal Kravcenko
committed
}
if( this->velocity ){

Michal Kravcenko
committed
}
}
Martin Beseda
committed
return this->coordinate;
}
double Particle::get_current_value() {
return this->current_val;
}

Michal Kravcenko
committed
double Particle::get_optimal_value() {
return this->optimal_value;
}
void Particle::get_optimal_coordinate(std::vector<double> &ref_coordinate) {

Michal Kravcenko
committed
for( unsigned int i = 0; i < this->coordinate_dim; ++i ){
ref_coordinate[i] = (*this->optimal_coordinate)[i];

Michal Kravcenko
committed
}
}
double Particle::change_coordinate(double w, double c1, double c2, std::vector<double> &glob_min_coord, std::vector<std::vector<double>> &global_min_vec, double penalty_coef) {

Michal Kravcenko
committed
/**
* v = w * v + c1r1(p_min_loc - x) + c2r2(p_min_glob - x) + c3r3(random_global_min - x)

Michal Kravcenko
committed
* x = x + v
*/
Martin Beseda
committed
double vel_mem;
/* Choose random global minima */
std::random_device rand_dev;
std::mt19937 engine{rand_dev()};
std::uniform_int_distribution<int> dist(0, global_min_vec.size() - 1);
random_global_best = &global_min_vec[dist(engine)];
// TODO use std::sample to choose random vector
//std::sample(global_min_vec.begin(), global_min_vec.end(), std::back_inserter(random_global_best), 1, std::mt19937{std::random_device{}()});

Michal Kravcenko
committed
for(unsigned int i = 0; i < this->coordinate_dim; ++i) {
vel_mem = w * (*this->velocity)[i]
+ c1 * this->r1 * ((*this->optimal_coordinate)[i] - (*this->coordinate)[i])
+ c2 * this->r2 * (glob_min_coord[i] - (*this->coordinate)[i]);
// + (c1+c2)/2 * this->r3 * ((*random_global_best)[i] - (*this->coordinate)[i]);
if ((*this->coordinate)[i] + vel_mem > this->domain_bounds[2 * i + 1]) {
this->randomize_velocity();
this->randomize_parameters();
this->randomize_coordinates();
break;
} else if ((*this->coordinate)[i] + vel_mem < this->domain_bounds[2 * i]) {
this->randomize_velocity();
this->randomize_parameters();
this->randomize_coordinates();
break;
}
}

Michal Kravcenko
committed
for(unsigned int i = 0; i < this->coordinate_dim; ++i){
vel_mem = w * (*this->velocity)[i]
+ c1 * this->r1 * ((*this->optimal_coordinate)[i] - (*this->coordinate)[i])
+ c2 * this->r2 * (glob_min_coord[i] - (*this->coordinate)[i])
+ (c1+c2)/2 * this->r3 * ((*random_global_best)[i] - (*this->coordinate)[i]);

Michal Kravcenko
committed
(*this->velocity)[i] = vel_mem;
(*this->coordinate)[i] += vel_mem;

Michal Kravcenko
committed
Martin Beseda
committed
output += std::abs(vel_mem);

Michal Kravcenko
committed
}
vel_mem = this->ef->eval(this->coordinate);
this->current_val = vel_mem;

Michal Kravcenko
committed
if(vel_mem < this->optimal_value){
this->optimal_value = vel_mem;
for(unsigned int i = 0; i < this->coordinate_dim; ++i){
(*this->optimal_coordinate)[i] = (*this->coordinate)[i];

Michal Kravcenko
committed
}
}
return output;
}
void Particle::print_coordinate() {
for(unsigned int i = 0; i < this->coordinate_dim - 1; ++i){

Michal Kravcenko
committed
}
printf("%10.8f\n", (*this->coordinate)[this->coordinate_dim - 1]);

Michal Kravcenko
committed
}
ParticleSwarm::ParticleSwarm(ErrorFunction* ef, double *domain_bounds,
double c1, double c2, double w, size_t n_particles, size_t iter_max) {

Michal Kravcenko
committed
srand(time(NULL));

Michal Kravcenko
committed

Michal Kravcenko
committed
this->c1 = c1;
this->c2 = c2;
this->c3 = (c1 + c2)/2.0;

Michal Kravcenko
committed
this->w = w;
this->n_particles = n_particles;
this->iter_max = iter_max;
this->particle_swarm = new Particle*[this->n_particles];
for( size_t pi = 0; pi < this->n_particles; ++pi ){
this->particle_swarm[pi] = new Particle(ef, domain_bounds);

Michal Kravcenko
committed
}
this->domain_bounds = domain_bounds;
}
ParticleSwarm::~ParticleSwarm() {
if( this->particle_swarm ){

Michal Kravcenko
committed
delete this->particle_swarm[i];
}
delete [] this->particle_swarm;
}
if(this->p_min_glob){
delete this->p_min_glob;
this->p_min_glob = nullptr;
}

Michal Kravcenko
committed
}
Martin Beseda
committed
/**
*
* @param gamma
* @param epsilon
* @param delta
*/
void ParticleSwarm::optimize( double gamma, double epsilon, double delta) {
if(epsilon < 0 || gamma < 0 || delta < 0) {
throw std::invalid_argument("Parameters 'gamma', 'epsilon' and 'delta' must be greater than or equal to zero!");
}
if(!this->p_min_glob){
this->p_min_glob = new std::vector<double>(this->func_dim);
}

Michal Kravcenko
committed

Michal Kravcenko
committed
Particle *particle;
std::vector<std::vector<double>> global_best_vec;

Michal Kravcenko
committed
double optimal_value = 0.0;

Michal Kravcenko
committed
Martin Beseda
committed
std::set<Particle*> cluster; //!< Particles in a cluster
std::vector<double>* centroid = new std::vector<double>(this->func_dim);//<! Centroid coordinates

Michal Kravcenko
committed
Martin Beseda
committed
double tmp_velocity;
double prev_max_velocity = 0;
double max_velocity;
double max_vel_step = 0;
double prev_max_vel_step;

Michal Kravcenko
committed
this->determine_optimal_coordinate_and_value(*this->p_min_glob, optimal_value);
// for(unsigned int i = 0; i < this->n_particles; ++i){
// this->particle_swarm[i]->print_coordinate();
// }
printf("Initial best value: %10.8f\n", optimal_value);
Martin Beseda
committed
while( outer_it < this->iter_max ) {
max_velocity = 0;

Michal Kravcenko
committed
Martin Beseda
committed
//////////////////////////////////////////////////
// Clustering algorithm - termination condition //
//////////////////////////////////////////////////
particle = this->determine_optimal_coordinate_and_value(*this->p_min_glob, optimal_value);
if(std::find(global_best_vec.begin(), global_best_vec.end(), *this->p_min_glob) == global_best_vec.end()) {
global_best_vec.emplace_back(*this->p_min_glob); // TODO rewrite as std::set
Martin Beseda
committed
cluster.insert(particle);

Michal Kravcenko
committed
//for(unsigned int i=0; i < 5; i++) {
/* Zero AVG coordinates */
std::fill(centroid->begin(), centroid->end(), 0);
std::vector<double> *c_ptr;

Michal Kravcenko
committed
Martin Beseda
committed
/* Looking for a centroid */
for (auto it : cluster) {
c_ptr = it->get_coordinate();
for (size_t di = 0; di < this->func_dim; di++) {
(*centroid)[di] += (*c_ptr)[di];
Martin Beseda
committed
}

Michal Kravcenko
committed
}
for(size_t di = 0; di < this->func_dim; di++) {
(*centroid)[di] /= cluster.size();
Martin Beseda
committed
}
Martin Beseda
committed
particle = this->particle_swarm[pi];
tmp_velocity = particle->change_coordinate( this->w, this->c1, this->c2, *this->p_min_glob, global_best_vec);

Michal Kravcenko
committed
particle->print_coordinate();
Martin Beseda
committed
if(tmp_velocity > max_velocity) {
prev_max_velocity = max_velocity;
max_velocity = tmp_velocity;
}
/* Looking for nearby particles */
//printf("iter: %d, pi: %d, euclidean dist: %f\n", outer_it, pi, this->get_euclidean_distance(particle->get_coordinate(), coords, this->func_dim));
// TODO - only in verbose mode
// only for info purposes
euclidean_dist += this->get_euclidean_distance(particle->get_coordinate(), centroid);
if(this->get_euclidean_distance(particle->get_coordinate(), centroid) < epsilon) {
Martin Beseda
committed
cluster.insert(particle);
}
}

Michal Kravcenko
committed
Martin Beseda
committed
prev_max_vel_step = max_vel_step;
max_vel_step = max_velocity - prev_max_velocity;

Michal Kravcenko
committed
//TODO only in verbose mode
euclidean_dist /= this->n_particles;
printf("Iteration %d, avg euclidean distance: %f, cluster percent: %f, f-value: %f\n", (int)outer_it, euclidean_dist,
double(cluster.size())/this->n_particles, optimal_value);

Michal Kravcenko
committed
std::cout.flush();
// for(unsigned int i=0; i < this->n_particles; i++) {
// printf("Particle %d (%f): \n", i, this->particle_swarm[i]->get_current_value());
// for(unsigned int j=0; j < this->func_dim; j++) {
// printf("\t%f\n", this->particle_swarm[i]->get_coordinate()[j]);
// }
// }
Martin Beseda
committed
/* Check if the particles are near to each other AND the maximal velocity is less than 'gamma' */
if(cluster.size() > delta * this->n_particles && std::abs(prev_max_vel_step/max_vel_step) > gamma) {
Martin Beseda
committed
break;
}

Michal Kravcenko
committed
outer_it++;
Martin Beseda
committed
// this->w *= 0.99;

Michal Kravcenko
committed
}
this->determine_optimal_coordinate_and_value(*this->p_min_glob, optimal_value);
if(outer_it < this->iter_max) {
/* Convergence reached */

Michal Kravcenko
committed
printf("\nFound optimum in %d iterations: %10.8f at coordinates: \n", (int)outer_it, optimal_value);
for (size_t i = 0; i <= this->func_dim - 1; ++i) {
printf("%10.8f \n", (*this->p_min_glob)[i]);
}
} else {
/* Maximal number of iterations reached */

Michal Kravcenko
committed
printf("\nMax number of iterations reached (%d)! Found value %10.8f at coordinates: \n", (int)outer_it, optimal_value);
for (size_t i = 0; i <= this->func_dim - 1; ++i) {
printf("\t%10.8f \n", (*this->p_min_glob)[i]);

Michal Kravcenko
committed
}
//delete [] p_min_glob; // TODO

Michal Kravcenko
committed
}
Particle* ParticleSwarm::determine_optimal_coordinate_and_value(std::vector<double> &coord, double &val) {
Martin Beseda
committed
Particle* p;

Michal Kravcenko
committed
val = this->particle_swarm[0]->get_optimal_value( );
this->particle_swarm[0]->get_optimal_coordinate(coord);
Martin Beseda
committed
p = this->particle_swarm[0];

Michal Kravcenko
committed

Michal Kravcenko
committed
double val_m = this->particle_swarm[i]->get_optimal_value( );
if(val_m < val){
val = val_m;
this->particle_swarm[i]->get_optimal_coordinate(coord);
Martin Beseda
committed
p = this->particle_swarm[i];
}
}
return p;
}
std::vector<double>* ParticleSwarm::get_centroid_coordinates() {
std::vector<double>* coords = new std::vector<double>(this->func_dim);
std::vector<double>* tmp;
Martin Beseda
committed
for (size_t pi = 0; pi < this->n_particles; pi++) {
Martin Beseda
committed
tmp = this->particle_swarm[pi]->get_coordinate();
for (size_t di = 0; di < this->func_dim; di++) {
(*coords)[di] += (*tmp)[di];
Martin Beseda
committed
}
}
for(size_t di = 0; di < this->func_dim; di++) {
(*coords)[di] /= this->n_particles;
Martin Beseda
committed
}
return coords;
}
double ParticleSwarm::get_euclidean_distance(std::vector<double>* a, std::vector<double>* b) {
double dist = 0, m;
for(size_t i = 0; i < a->size(); i++) {
m = (*a)[i]-(*b)[i];
m *= m;
dist += m;

Michal Kravcenko
committed
}
Martin Beseda
committed
return std::sqrt(dist);
}
std::vector<double>* ParticleSwarm::get_solution() {
return this->p_min_glob;