Skip to content
Snippets Groups Projects
ParticleSwarm.cpp 13.3 KiB
Newer Older
  • Learn to ignore specific revisions
  • /**
     * DESCRIPTION OF THE FILE
     *
     * @author Michal Kravčenko
     * @date 2.7.18 -
     */
    
    
    David Vojtek's avatar
    David Vojtek committed
    /**
     * TODO
     * domain_bound out_of_range check
     * @param f_dim
     * @param domain_bounds
     * @param F
     */
    
    Michal Kravcenko's avatar
    Michal Kravcenko committed
        std::random_device seeder;
        std::mt19937 gen(seeder());
    
        for(unsigned int i = 0; i < this->coordinate_dim; ++i){
    
            std::uniform_real_distribution<double> dist_coord(-1, 1);
    
        std::random_device seeder;
        std::mt19937 gen(seeder());
        std::uniform_real_distribution<double> dist_vel(0.5, 1.0);
    
    Michal Kravcenko's avatar
    Michal Kravcenko committed
        this->r1 = dist_vel(gen);
        this->r2 = dist_vel(gen);
        this->r3 = dist_vel(gen);
    
    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);
        }
    }
    
    Particle::Particle(ErrorFunction *ef, std::vector<double> *domain_bounds) {
    
        this->ef = ef;
    
        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){
    
    Michal Kravcenko's avatar
    Michal Kravcenko committed
            (*this->optimal_coordinate)[i] = (*this->coordinate)[i];
    
        this->optimal_value = this->ef->eval(this->coordinate);
    
    Michal Kravcenko's avatar
    Michal Kravcenko committed
            delete this->optimal_coordinate;
    
    Michal Kravcenko's avatar
    Michal Kravcenko committed
            delete this->coordinate;
    
    Michal Kravcenko's avatar
    Michal Kravcenko committed
            delete this->velocity;
    
    Michal Kravcenko's avatar
    Michal Kravcenko committed
    std::vector<double>* Particle::get_coordinate() {
    
    double Particle::get_current_value() {
        return this->current_val;
    }
    
    
    double Particle::get_optimal_value() {
        return this->optimal_value;
    }
    
    
    void Particle::get_optimal_coordinate(std::vector<double> &ref_coordinate) {
    
        for( unsigned int i = 0; i < this->coordinate_dim; ++i ){
    
    Michal Kravcenko's avatar
    Michal Kravcenko committed
            ref_coordinate[i] = (*this->optimal_coordinate)[i];
    
    Michal Kravcenko's avatar
    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) {
    
         * v = w * v + c1r1(p_min_loc - x) + c2r2(p_min_glob - x) + c3r3(random_global_min - x)
    
    Michal Kravcenko's avatar
    Michal Kravcenko committed
        double output = 0.0;
    
    
        /* Choose random global minima */
    
    Michal Kravcenko's avatar
    Michal Kravcenko committed
        std::vector<double> *random_global_best;
    
        std::random_device rand_dev;
        std::mt19937 engine{rand_dev()};
    
        std::uniform_int_distribution<size_t> dist(0, global_min_vec.size() - 1);
    
    Michal Kravcenko's avatar
    Michal Kravcenko committed
        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{}()});
    
    
        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->at(2 * i + 1)) {
    
                this->randomize_velocity();
                this->randomize_parameters();
                this->randomize_coordinates();
                break;
    
            } else if ((*this->coordinate)[i] + vel_mem < this->domain_bounds->at(2 * i)) {
    
                this->randomize_velocity();
                this->randomize_parameters();
                this->randomize_coordinates();
                break;
            }
        }
    
    
        for(unsigned int i = 0; i < this->coordinate_dim; ++i){
    
    Michal Kravcenko's avatar
    Michal Kravcenko committed
            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's avatar
    Michal Kravcenko committed
            (*this->velocity)[i] = vel_mem;
            (*this->coordinate)[i] += vel_mem;
    
        vel_mem = this->ef->eval(this->coordinate);
    
        this->current_val = vel_mem;
    
    
        if(vel_mem < this->optimal_value){
            this->optimal_value = vel_mem;
            for(unsigned int i = 0; i < this->coordinate_dim; ++i){
    
    Michal Kravcenko's avatar
    Michal Kravcenko committed
                (*this->optimal_coordinate)[i] = (*this->coordinate)[i];
    
            }
        }
    
        return output;
    }
    
    void Particle::print_coordinate() {
        for(unsigned int i = 0; i < this->coordinate_dim - 1; ++i){
    
    Michal Kravcenko's avatar
    Michal Kravcenko committed
            printf("%10.8f, ", (*this->coordinate)[i]);
    
    Michal Kravcenko's avatar
    Michal Kravcenko committed
        printf("%10.8f\n", (*this->coordinate)[this->coordinate_dim - 1]);
    
    ParticleSwarm::ParticleSwarm(
            std::vector<double> *domain_bounds,
            double c1,
            double c2,
            double w,
            double gamma,
            double epsilon,
            double delta,
            size_t n_particles,
            size_t iter_max
        ) {
    
    
        if(epsilon < 0 || gamma < 0 || delta < 0) {
            throw std::invalid_argument("Parameters 'gamma', 'epsilon' and 'delta' must be greater than or equal to zero!");
        }
    
        this->gamma = gamma;
    
        this->epsilon = epsilon;
    
        this->delta = delta;
    
    
        this->n_particles = n_particles;
    
        this->iter_max = iter_max;
    
    
        this->particle_swarm = new std::vector<Particle*>( this->n_particles );
    
        this->domain_bounds = domain_bounds;
    
        std::fill( this->particle_swarm->begin(), this->particle_swarm->end(), nullptr );
    
    Michal Kravcenko's avatar
    Michal Kravcenko committed
            for( size_t i = 0; i < this->n_particles; ++i ){
    
                delete this->particle_swarm->at( i );
    
            delete this->particle_swarm;
            this->particle_swarm = nullptr;
    
    Michal Kravcenko's avatar
    Michal Kravcenko committed
        if(this->p_min_glob){
            delete this->p_min_glob;
            this->p_min_glob = nullptr;
        }
    
    
    void ParticleSwarm::optimize( ErrorFunction &ef ) {
    
        if(this->domain_bounds->size() < 2 * ef.get_dimension()){
            std::cerr << "The supplied domain bounds dimension is too low! It should be at least " << 2 * ef.get_dimension() << "\n" << std::endl;
    
    
        this->func_dim = ef.get_dimension();
    
        /* initialize the particles */
        for( size_t pi = 0; pi < this->n_particles; ++pi ){
            if(this->particle_swarm->at( pi )){
                delete this->particle_swarm->at( pi );
            }
            this->particle_swarm->at( pi ) = new Particle( &ef, this->domain_bounds );
        }
    
    
    Michal Kravcenko's avatar
    Michal Kravcenko committed
        if(!this->p_min_glob){
            this->p_min_glob = new std::vector<double>(this->func_dim);
        }
    
        else{
            this->p_min_glob->resize(this->func_dim);
        }
    
    Michal Kravcenko's avatar
    Michal Kravcenko committed
        size_t outer_it = 0;
    
        std::vector<std::vector<double>> global_best_vec;
    
        std::set<Particle*> cluster; //!< Particles in a cluster
    
    Michal Kravcenko's avatar
    Michal Kravcenko committed
        std::vector<double>* centroid = new std::vector<double>(this->func_dim);//<! Centroid coordinates
    
        double tmp_velocity;
        double prev_max_velocity = 0;
        double max_velocity;
        double max_vel_step = 0;
        double prev_max_vel_step;
    
        double euclidean_dist;
    
    Michal Kravcenko's avatar
    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);
    
    
        while( outer_it < this->iter_max ) {
            max_velocity = 0;
    
            euclidean_dist = 0;
    
            //////////////////////////////////////////////////
            // Clustering algorithm - termination condition //
            //////////////////////////////////////////////////
    
    Michal Kravcenko's avatar
    Michal Kravcenko committed
            particle = this->determine_optimal_coordinate_and_value(*this->p_min_glob, optimal_value);
    
    Michal Kravcenko's avatar
    Michal Kravcenko committed
            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
    
            //for(unsigned int i=0; i < 5; i++) {
                /* Zero AVG coordinates */
    
    Michal Kravcenko's avatar
    Michal Kravcenko committed
                std::fill(centroid->begin(), centroid->end(), 0);
                std::vector<double> *c_ptr;
    
                /* Looking for a centroid */
                for (auto it : cluster) {
    
    Michal Kravcenko's avatar
    Michal Kravcenko committed
                    c_ptr = it->get_coordinate();
                    for (size_t di = 0; di < this->func_dim; di++) {
                        (*centroid)[di] += (*c_ptr)[di];
    
    Michal Kravcenko's avatar
    Michal Kravcenko committed
                for(size_t di = 0; di < this->func_dim; di++) {
                    (*centroid)[di] /= cluster.size();
    
    Michal Kravcenko's avatar
    Michal Kravcenko committed
                for(size_t pi=0; pi < this->n_particles; pi++) {
    
                    particle = this->particle_swarm->at(pi);
    
    Michal Kravcenko's avatar
    Michal Kravcenko committed
                    tmp_velocity = particle->change_coordinate( this->w, this->c1, this->c2, *this->p_min_glob, global_best_vec);
    
    
                    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) < this->epsilon) {
    
            prev_max_vel_step = max_vel_step;
            max_vel_step = max_velocity - prev_max_velocity;
    
            //TODO only in verbose mode
            euclidean_dist /= this->n_particles;
    
                //printf("Iteration %d, avg euclidean distance: %f, cluster percent: %f, f-value: %f\r", (int)outer_it, euclidean_dist,
                //       double(cluster.size())/this->n_particles, optimal_value);
                //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]);
    //            }
    //        }
    
    
            /* Check if the particles are near to each other AND the maximal velocity is less than 'gamma' */
    
            if( cluster.size() > this->delta * this->n_particles && prev_max_vel_step < this->gamma * max_vel_step ) {
    
    Michal Kravcenko's avatar
    Michal Kravcenko committed
        this->determine_optimal_coordinate_and_value(*this->p_min_glob, optimal_value);
    
        if(outer_it < this->iter_max) {
            /* Convergence reached */
    
            printf("\nFound optimum in %d iterations. Objective function value: %10.8f\n", (int)outer_it, optimal_value);
    
        } else {
            /* Maximal number of iterations reached */
    
            printf("\nMax number of iterations reached (%d)!  Objective function value: %10.8f\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]);
    //    }
    //
    //    this->f->eval( this->get_solution() );
    
    
    Michal Kravcenko's avatar
    Michal Kravcenko committed
        delete centroid;
    
    Particle* ParticleSwarm::determine_optimal_coordinate_and_value(std::vector<double> &coord, double &val) {
    
        val = this->particle_swarm->at(0)->get_optimal_value( );
        this->particle_swarm->at(0)->get_optimal_coordinate(coord);
        p = this->particle_swarm->at(0);
    
    Michal Kravcenko's avatar
    Michal Kravcenko committed
        for(size_t i = 1; i < this->n_particles; ++i){
    
            double val_m = this->particle_swarm->at(i)->get_optimal_value( );
    
                this->particle_swarm->at(i)->get_optimal_coordinate(coord);
                p = this->particle_swarm->at(i);
    
    Michal Kravcenko's avatar
    Michal Kravcenko committed
    std::vector<double>* ParticleSwarm::get_centroid_coordinates() {
        std::vector<double>* coords = new std::vector<double>(this->func_dim);
        std::vector<double>* tmp;
    
    Michal Kravcenko's avatar
    Michal Kravcenko committed
        for (size_t pi = 0; pi < this->n_particles; pi++) {
    
            tmp = this->particle_swarm->at(pi)->get_coordinate();
    
    Michal Kravcenko's avatar
    Michal Kravcenko committed
            for (size_t di = 0; di < this->func_dim; di++) {
                (*coords)[di] += (*tmp)[di];
    
    Michal Kravcenko's avatar
    Michal Kravcenko committed
        for(size_t di = 0; di < this->func_dim; di++) {
            (*coords)[di] /= this->n_particles;
    
    Michal Kravcenko's avatar
    Michal Kravcenko committed
    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;
    
    std::vector<double>* ParticleSwarm::get_parameters( ) {
    
    Michal Kravcenko's avatar
    Michal Kravcenko committed
        return this->p_min_glob;