Example #1
0
 def _internal_evaluator(self, candidates, args):
     the_generator = args.get('the_generator')
     the_evaluator = args.get('the_evaluator')
     do_maximize = args.get('do_maximize', True)
 
     fitness = []
     for candidate in candidates:
         popsize, selector, replacer, crossover, mutator, myargs = self.interpret_candidate(candidate)
         myargs['max_evaluations'] = args.get('num_trial_evaluations', popsize * 10)
         num_trials = args.get('num_trials', 1)
         evo = ec.EvolutionaryComputation(self._random)
         evo.terminator = self._internal_terminator
         evo.observer = self._internal_observer
         evo.selector = selector
         evo.variator = [crossover, mutator]
         evo.replacer = replacer
         best_fit = []
         for i in range(num_trials):
             final_pop = evo.evolve(generator=the_generator,
                                    evaluator=the_evaluator,
                                    pop_size=popsize,
                                    maximize=do_maximize,
                                    args=myargs)
             best_fit.append(final_pop[0].fitness)
         fitness.append(sum(best_fit) / float(len(best_fit)))
     return fitness
Example #2
0
def evolve_memory_solvers(nodes,
                          paths,
                          solvers,
                          sel_pressure,
                          generations,
                          maze_function=generate_simple_maze):
    #performs evolutionary computuation for memory solvers
    rand = Random()
    rand.seed(int(time()))
    computation = ec.EvolutionaryComputation(rand)
    computation.terminator = ec.terminators.generation_termination
    computation.selector = ec.selectors.rank_selection  #could use rank or truncation or discard_useless
    computation.variator = variate_memory_solver  #could use default ec.variators.default_variation
    computation.replacer = ec.replacers.truncation_replacement  #could use steady_state
    computation.observer = ec.observers.stats_observer  #could use test_observer
    #migrator is default for now
    #archiver is default for now
    gen_maze = maze_function(rand, nodes, paths)

    return computation.evolve(generate_memory_solver,
                              evaluate_memory_solver,
                              pop_size=solvers,
                              maximize=False,
                              maze=gen_maze,
                              num_selected=sel_pressure,
                              max_generations=generations)
Example #3
0
def evolOptim(self, pc):
    """
    Function for/to <short description of `netpyne.batch.evol.evolOptim`>

    Parameters
    ----------
    self : <type>
        <Short description of self>
        **Default:** *required*

    pc : <type>
        <Short description of pc>
        **Default:** *required*


    """

    import sys
    import inspyred.ec as EC

    # -------------------------------------------------------------------------------
    # Evolutionary optimization: Parallel evaluation
    # -------------------------------------------------------------------------------
    def evaluator(candidates, args):
        import os
        import signal
        global ngen
        ngen += 1
        total_jobs = 0

        # options slurm, mpi
        type = args.get('type', 'mpi_direct')

        # paths to required scripts
        script = args.get('script', 'init.py')
        netParamsSavePath = args.get('netParamsSavePath')
        genFolderPath = self.saveFolder + '/gen_' + str(ngen)

        # mpi command setup
        nodes = args.get('nodes', 1)
        paramLabels = args.get('paramLabels', [])
        coresPerNode = args.get('coresPerNode', 1)
        mpiCommand = args.get('mpiCommand', 'mpirun')
        nrnCommand = args.get('nrnCommand', 'nrniv')

        numproc = nodes * coresPerNode

        # slurm setup
        custom = args.get('custom', '')
        folder = args.get('folder', '.')
        email = args.get('email', '[email protected]')
        walltime = args.get('walltime', '00:01:00')
        reservation = args.get('reservation', None)
        allocation = args.get('allocation', 'csd403')  # NSG account

        # fitness function
        fitnessFunc = args.get('fitnessFunc')
        fitnessFuncArgs = args.get('fitnessFuncArgs')
        defaultFitness = args.get('defaultFitness')

        # read params or set defaults
        sleepInterval = args.get('sleepInterval', 0.2)

        # create folder if it does not exist
        createFolder(genFolderPath)

        # remember pids and jobids in a list
        pids = []
        jobids = {}

        # create a job for each candidate
        for candidate_index, candidate in enumerate(candidates):
            # required for slurm
            sleep(sleepInterval)

            # name and path
            jobName = "gen_" + str(ngen) + "_cand_" + str(candidate_index)
            jobPath = genFolderPath + '/' + jobName

            # set initial cfg initCfg
            if len(self.initCfg) > 0:
                for paramLabel, paramVal in self.initCfg.items():
                    self.setCfgNestedParam(paramLabel, paramVal)

            # modify cfg instance with candidate values
            for label, value in zip(paramLabels, candidate):
                print('set %s=%s' % (label, value))
                self.setCfgNestedParam(label, value)

            #self.setCfgNestedParam("filename", jobPath)
            self.cfg.simLabel = jobName
            self.cfg.saveFolder = genFolderPath

            # save cfg instance to file
            cfgSavePath = jobPath + '_cfg.json'
            self.cfg.save(cfgSavePath)

            if type == 'mpi_bulletin':
                # ----------------------------------------------------------------------
                # MPI master-slaves
                # ----------------------------------------------------------------------
                pc.submit(runEvolJob, nrnCommand, script, cfgSavePath,
                          netParamsSavePath, jobPath)
                print('-' * 80)

            else:
                # ----------------------------------------------------------------------
                # MPI job commnand
                # ----------------------------------------------------------------------
                if mpiCommand == '':
                    command = '%s %s simConfig=%s netParams=%s ' % (
                        nrnCommand, script, cfgSavePath, netParamsSavePath)
                else:
                    command = '%s -np %d %s -python -mpi %s simConfig=%s netParams=%s ' % (
                        mpiCommand, numproc, nrnCommand, script, cfgSavePath,
                        netParamsSavePath)

                # ----------------------------------------------------------------------
                # run on local machine with <nodes*coresPerNode> cores
                # ----------------------------------------------------------------------
                if type == 'mpi_direct':
                    executer = '/bin/bash'
                    jobString = bashTemplate('mpi_direct') % (custom, folder,
                                                              command)

                # ----------------------------------------------------------------------
                # run on HPC through slurm
                # ----------------------------------------------------------------------
                elif type == 'hpc_slurm':
                    executer = 'sbatch'
                    res = '#SBATCH --res=%s' % (
                        reservation) if reservation else ''
                    jobString = bashTemplate('hpc_slurm') % (
                        jobName, allocation, walltime, nodes, coresPerNode,
                        jobPath, jobPath, email, res, custom, folder, command)

                # ----------------------------------------------------------------------
                # run on HPC through PBS
                # ----------------------------------------------------------------------
                elif type == 'hpc_torque':
                    executer = 'qsub'
                    queueName = args.get('queueName', 'default')
                    nodesppn = 'nodes=%d:ppn=%d' % (nodes, coresPerNode)
                    jobString = bashTemplate('hpc_torque') % (
                        jobName, walltime, queueName, nodesppn, jobPath,
                        jobPath, custom, command)

                # ----------------------------------------------------------------------
                # save job and run
                # ----------------------------------------------------------------------
                print('Submitting job ', jobName)
                print(jobString)
                print('-' * 80)
                # save file
                batchfile = '%s.sbatch' % (jobPath)
                with open(batchfile, 'w') as text_file:
                    text_file.write("%s" % jobString)

                #with open(jobPath+'.run', 'a+') as outf, open(jobPath+'.err', 'w') as errf:
                with open(jobPath + '.jobid',
                          'w') as outf, open(jobPath + '.err', 'w') as errf:
                    pids.append(
                        Popen([executer, batchfile],
                              stdout=outf,
                              stderr=errf,
                              preexec_fn=os.setsid).pid)
                #proc = Popen(command.split([executer, batchfile]), stdout=PIPE, stderr=PIPE)
                sleep(0.1)
                #read = proc.stdout.read()
                with open(jobPath + '.jobid', 'r') as outf:
                    read = outf.readline()
                print(read)
                if len(read) > 0:
                    jobid = int(read.split()[-1])
                    jobids[candidate_index] = jobid
                print('jobids', jobids)
            total_jobs += 1
            sleep(0.1)

        # ----------------------------------------------------------------------
        # gather data and compute fitness
        # ----------------------------------------------------------------------
        if type == 'mpi_bulletin':
            # wait for pc bulletin board jobs to finish
            try:
                while pc.working():
                    sleep(1)
                #pc.done()
            except:
                pass

        num_iters = 0
        jobs_completed = 0
        fitness = [None for cand in candidates]
        # print outfilestem
        print("Waiting for jobs from generation %d/%d ..." %
              (ngen, args.get('max_generations')))
        # print "PID's: %r" %(pids)
        # start fitness calculation
        while jobs_completed < total_jobs:
            unfinished = [i for i, x in enumerate(fitness) if x is None]
            for candidate_index in unfinished:
                try:  # load simData and evaluate fitness
                    jobNamePath = genFolderPath + "/gen_" + str(
                        ngen) + "_cand_" + str(candidate_index)
                    if os.path.isfile(jobNamePath + '.json'):
                        with open('%s.json' % (jobNamePath)) as file:
                            simData = json.load(file)['simData']
                        fitness[candidate_index] = fitnessFunc(
                            simData, **fitnessFuncArgs)
                        jobs_completed += 1
                        print('  Candidate %d fitness = %.1f' %
                              (candidate_index, fitness[candidate_index]))
                    elif os.path.isfile(jobNamePath + '.pkl'):
                        with open('%s.pkl' % (jobNamePath), 'rb') as file:
                            simData = pickle.load(file)['simData']
                        fitness[candidate_index] = fitnessFunc(
                            simData, **fitnessFuncArgs)
                        jobs_completed += 1
                        print('  Candidate %d fitness = %.1f' %
                              (candidate_index, fitness[candidate_index]))
                except Exception as e:
                    # print
                    err = "There was an exception evaluating candidate %d:" % (
                        candidate_index)
                    print(("%s \n %s" % (err, e)))
                    #pass
                    #print 'Error evaluating fitness of candidate %d'%(candidate_index)
            num_iters += 1
            print('completed: %d' % (jobs_completed))
            if num_iters >= args.get('maxiter_wait', 5000):
                print(
                    "Max iterations reached, the %d unfinished jobs will be canceled and set to default fitness"
                    % (len(unfinished)))
                for canditade_index in unfinished:
                    fitness[canditade_index] = defaultFitness
                    jobs_completed += 1
                    try:
                        if 'scancelUser' in kwargs:
                            os.system('scancel -u %s' %
                                      (kwargs['scancelUser']))
                        else:
                            os.system(
                                'scancel %d' % (jobids[candidate_index])
                            )  # terminate unfinished job (resubmitted jobs not terminated!)
                    except:
                        pass
            sleep(args.get('time_sleep', 1))

        # kill all processes
        if type == 'mpi_bulletin':
            try:
                with open("./pids.pid",
                          'r') as file:  # read pids for mpi_bulletin
                    pids = [int(i) for i in file.read().split(' ')[:-1]]

                with open("./pids.pid", 'w') as file:  # delete content
                    pass
                for pid in pids:
                    try:
                        os.killpg(os.getpgid(pid), signal.SIGTERM)
                    except:
                        pass
            except:
                pass
        # don't want to to this for hpcs since jobs are running on compute nodes not master
        # else:
        #     try:
        #         for pid in pids: os.killpg(os.getpgid(pid), signal.SIGTERM)
        #     except:
        #         pass
        # return
        print("-" * 80)
        print("  Completed a generation  ")
        print("-" * 80)
        return fitness

    # -------------------------------------------------------------------------------
    # Evolutionary optimization: Generation of first population candidates
    # -------------------------------------------------------------------------------
    def generator(random, args):
        # generate initial values for candidates
        return [
            random.uniform(l, u)
            for l, u in zip(args.get('lower_bound'), args.get('upper_bound'))
        ]

    # -------------------------------------------------------------------------------
    # Mutator
    # -------------------------------------------------------------------------------
    @EC.variators.mutator
    def nonuniform_bounds_mutation(random, candidate, args):
        """Return the mutants produced by nonuniform mutation on the candidates.
        .. Arguments:
            random -- the random number generator object
            candidate -- the candidate solution
            args -- a dictionary of keyword arguments
        Required keyword arguments in args:
        Optional keyword arguments in args:
        - *mutation_strength* -- the strength of the mutation, where higher
            values correspond to greater variation (default 1)
        """
        lower_bound = args.get('lower_bound')
        upper_bound = args.get('upper_bound')
        strength = args.setdefault('mutation_strength', 1)
        mutant = copy(candidate)
        for i, (c, lo,
                hi) in enumerate(zip(candidate, lower_bound, upper_bound)):
            if random.random() <= 0.5:
                new_value = c + (hi - c) * (1.0 - random.random()**strength)
            else:
                new_value = c - (c - lo) * (1.0 - random.random()**strength)
            mutant[i] = new_value

        return mutant

    # -------------------------------------------------------------------------------
    # Evolutionary optimization: Main code
    # -------------------------------------------------------------------------------
    import os
    # create main sim directory and save scripts
    self.saveScripts()

    global ngen
    ngen = -1

    # log for simulation
    logger = logging.getLogger('inspyred.ec')
    logger.setLevel(logging.DEBUG)
    file_handler = logging.FileHandler(self.saveFolder + '/inspyred.log',
                                       mode='a')
    file_handler.setLevel(logging.DEBUG)
    formatter = logging.Formatter(
        '%(asctime)s - %(name)s - %(levelname)s - %(message)s')
    file_handler.setFormatter(formatter)
    logger.addHandler(file_handler)

    # create randomizer instance
    rand = Random()
    rand.seed(self.seed)

    # create file handlers for observers
    stats_file, ind_stats_file = self.openFiles2SaveStats()

    # gather **kwargs
    kwargs = {'cfg': self.cfg}
    kwargs['num_inputs'] = len(self.params)
    kwargs['paramLabels'] = [x['label'] for x in self.params]
    kwargs['lower_bound'] = [x['values'][0] for x in self.params]
    kwargs['upper_bound'] = [x['values'][1] for x in self.params]
    kwargs['statistics_file'] = stats_file
    kwargs['individuals_file'] = ind_stats_file
    kwargs[
        'netParamsSavePath'] = self.saveFolder + '/' + self.batchLabel + '_netParams.py'

    for key, value in self.evolCfg.items():
        kwargs[key] = value
    if not 'maximize' in kwargs: kwargs['maximize'] = False

    for key, value in self.runCfg.items():
        kwargs[key] = value

    # if using pc bulletin board, initialize all workers
    if self.runCfg.get('type', None) == 'mpi_bulletin':
        for iworker in range(int(pc.nhost())):
            pc.runworker()

    #------------------------------------------------------------------
    # Evolutionary algorithm method
    #-------------------------------------------------------------------
    # Custom algorithm based on Krichmar's params
    if self.evolCfg['evolAlgorithm'] == 'custom':
        ea = EC.EvolutionaryComputation(rand)
        ea.selector = EC.selectors.tournament_selection
        ea.variator = [
            EC.variators.uniform_crossover, nonuniform_bounds_mutation
        ]
        ea.replacer = EC.replacers.generational_replacement
        if not 'tournament_size' in kwargs: kwargs['tournament_size'] = 2
        if not 'num_selected' in kwargs:
            kwargs['num_selected'] = kwargs['pop_size']

    # Genetic
    elif self.evolCfg['evolAlgorithm'] == 'genetic':
        ea = EC.GA(rand)

    # Evolution Strategy
    elif self.evolCfg['evolAlgorithm'] == 'evolutionStrategy':
        ea = EC.ES(rand)

    # Simulated Annealing
    elif self.evolCfg['evolAlgorithm'] == 'simulatedAnnealing':
        ea = EC.SA(rand)

    # Differential Evolution
    elif self.evolCfg['evolAlgorithm'] == 'diffEvolution':
        ea = EC.DEA(rand)

    # Estimation of Distribution
    elif self.evolCfg['evolAlgorithm'] == 'estimationDist':
        ea = EC.EDA(rand)

    # Particle Swarm optimization
    elif self.evolCfg['evolAlgorithm'] == 'particleSwarm':
        from inspyred import swarm
        ea = swarm.PSO(rand)
        ea.topology = swarm.topologies.ring_topology

    # Ant colony optimization (requires components)
    elif self.evolCfg['evolAlgorithm'] == 'antColony':
        from inspyred import swarm
        if not 'components' in kwargs:
            raise ValueError("%s requires components" %
                             (self.evolCfg['evolAlgorithm']))
        ea = swarm.ACS(rand, self.evolCfg['components'])
        ea.topology = swarm.topologies.ring_topology

    else:
        raise ValueError("%s is not a valid strategy" %
                         (self.evolCfg['evolAlgorithm']))

    ea.terminator = EC.terminators.generation_termination
    ea.observer = [EC.observers.stats_observer, EC.observers.file_observer]

    # -------------------------------------------------------------------------------
    # Run algorithm
    # -------------------------------------------------------------------------------
    final_pop = ea.evolve(generator=generator,
                          evaluator=evaluator,
                          bounder=EC.Bounder(kwargs['lower_bound'],
                                             kwargs['upper_bound']),
                          logger=logger,
                          **kwargs)

    # close file
    stats_file.close()
    ind_stats_file.close()

    # print best and finish
    print(('Best Solution: \n{0}'.format(str(max(final_pop)))))
    print("-" * 80)
    print("   Completed evolutionary algorithm parameter optimization   ")
    print("-" * 80)
    sys.exit()
Example #4
0
    def run(self):
        # -------------------------------------------------------------------------------
        # Grid Search optimization
        # -------------------------------------------------------------------------------
        if self.method in ['grid', 'list']:
            # create saveFolder
            import os, glob
            try:
                os.mkdir(self.saveFolder)
            except OSError:
                if not os.path.exists(self.saveFolder):
                    print ' Could not create', self.saveFolder

            # save Batch dict as json
            targetFile = self.saveFolder + '/' + self.batchLabel + '_batch.json'
            self.save(targetFile)

            # copy this batch script to folder
            targetFile = self.saveFolder + '/' + self.batchLabel + '_batchScript.py'
            os.system('cp ' + os.path.realpath(__file__) + ' ' + targetFile)

            # copy netParams source to folder
            netParamsSavePath = self.saveFolder + '/' + self.batchLabel + '_netParams.py'
            os.system('cp ' + self.netParamsFile + ' ' + netParamsSavePath)

            # import cfg
            cfgModuleName = os.path.basename(self.cfgFile).split('.')[0]
            cfgModule = imp.load_source(cfgModuleName, self.cfgFile)
            self.cfg = cfgModule.cfg
            self.cfg.checkErrors = False  # avoid error checking during batch

            # set initial cfg initCfg
            if len(self.initCfg) > 0:
                for paramLabel, paramVal in self.initCfg.iteritems():
                    self.setCfgNestedParam(paramLabel, paramVal)

            # iterate over all param combinations
            if self.method == 'grid':
                groupedParams = False
                ungroupedParams = False
                for p in self.params:
                    if 'group' not in p:
                        p['group'] = False
                        ungroupedParams = True
                    elif p['group'] == True:
                        groupedParams = True

                if ungroupedParams:
                    labelList, valuesList = zip(*[(p['label'], p['values'])
                                                  for p in self.params
                                                  if p['group'] == False])
                else:
                    labelList = ()
                    valuesList = ()

                labelList, valuesList = zip(*[(p['label'], p['values'])
                                              for p in self.params
                                              if p['group'] == False])
                valueCombinations = list(product(*(valuesList)))
                indexCombinations = list(
                    product(*[range(len(x)) for x in valuesList]))

                if groupedParams:
                    labelListGroup, valuesListGroup = zip(
                        *[(p['label'], p['values']) for p in self.params
                          if p['group'] == True])
                    valueCombGroups = izip(*(valuesListGroup))
                    indexCombGroups = izip(
                        *[range(len(x)) for x in valuesListGroup])
                    labelList = labelListGroup + labelList
                else:
                    valueCombGroups = [(0, )]  # this is a hack -- improve!
                    indexCombGroups = [(0, )]

            # if using pc bulletin board, initialize all workers
            if self.runCfg.get('type', None) == 'mpi_bulletin':
                for iworker in range(int(pc.nhost())):
                    pc.runworker()

            #if 1:
            #for iComb, pComb in zip(indexCombinations, valueCombinations):

            for iCombG, pCombG in zip(indexCombGroups, valueCombGroups):
                for iCombNG, pCombNG in zip(indexCombinations,
                                            valueCombinations):
                    if groupedParams:  # temporary hack - improve
                        iComb = iCombG + iCombNG
                        pComb = pCombG + pCombNG

                    else:
                        iComb = iCombNG
                        pComb = pCombNG

                    print iComb, pComb

                    for i, paramVal in enumerate(pComb):
                        paramLabel = labelList[i]
                        self.setCfgNestedParam(paramLabel, paramVal)

                        print str(paramLabel) + ' = ' + str(paramVal)

                    # set simLabel and jobName
                    simLabel = self.batchLabel + ''.join(
                        [''.join('_' + str(i)) for i in iComb])
                    jobName = self.saveFolder + '/' + simLabel

                    # skip if output file already exists
                    if self.runCfg.get('skip',
                                       False) and glob.glob(jobName + '.json'):
                        print 'Skipping job %s since output file already exists...' % (
                            jobName)
                    elif self.runCfg.get(
                            'skipCfg',
                            False) and glob.glob(jobName + '_cfg.json'):
                        print 'Skipping job %s since cfg file already exists...' % (
                            jobName)
                    elif self.runCfg.get(
                            'skipCustom',
                            None) and glob.glob(jobName +
                                                self.runCfg['skipCustom']):
                        print 'Skipping job %s since %s file already exists...' % (
                            jobName, self.runCfg['skipCustom'])
                    else:
                        # save simConfig json to saveFolder
                        self.cfg.simLabel = simLabel
                        self.cfg.saveFolder = self.saveFolder
                        cfgSavePath = self.saveFolder + '/' + simLabel + '_cfg.json'
                        self.cfg.save(cfgSavePath)

                        # hpc torque job submission
                        if self.runCfg.get('type', None) == 'hpc_torque':

                            # read params or set defaults
                            sleepInterval = self.runCfg.get('sleepInterval', 1)
                            sleep(sleepInterval)

                            nodes = self.runCfg.get('nodes', 1)
                            ppn = self.runCfg.get('ppn', 1)
                            script = self.runCfg.get('script', 'init.py')
                            mpiCommand = self.runCfg.get(
                                'mpiCommand', 'mpiexec')
                            walltime = self.runCfg.get('walltime', '00:30:00')
                            queueName = self.runCfg.get('queueName', 'default')
                            nodesppn = 'nodes=%d:ppn=%d' % (nodes, ppn)
                            custom = self.runCfg.get('custom', '')
                            numproc = nodes * ppn

                            command = '%s -np %d nrniv -python -mpi %s simConfig=%s netParams=%s' % (
                                mpiCommand, numproc, script, cfgSavePath,
                                netParamsSavePath)

                            jobString = """#!/bin/bash 
#PBS -N %s
#PBS -l walltime=%s
#PBS -q %s
#PBS -l %s
#PBS -o %s.run
#PBS -e %s.err
%s
cd $PBS_O_WORKDIR
echo $PBS_O_WORKDIR
%s
                            """ % (jobName, walltime, queueName, nodesppn,
                                   jobName, jobName, custom, command)

                            # Send job_string to qsub
                            print 'Submitting job ', jobName
                            print jobString + '\n'

                            batchfile = '%s.pbs' % (jobName)
                            with open(batchfile, 'w') as text_file:
                                text_file.write("%s" % jobString)

                            proc = Popen(['qsub', batchfile],
                                         stderr=PIPE,
                                         stdout=PIPE
                                         )  # Open a pipe to the qsub command.
                            (output, input) = (proc.stdin, proc.stdout)

                        # hpc torque job submission
                        elif self.runCfg.get('type', None) == 'hpc_slurm':

                            # read params or set defaults
                            sleepInterval = self.runCfg.get('sleepInterval', 1)
                            sleep(sleepInterval)

                            allocation = self.runCfg.get(
                                'allocation', 'csd403')  # NSG account
                            nodes = self.runCfg.get('nodes', 1)
                            coresPerNode = self.runCfg.get('coresPerNode', 1)
                            email = self.runCfg.get('email', '[email protected]')
                            folder = self.runCfg.get('folder', '.')
                            script = self.runCfg.get('script', 'init.py')
                            mpiCommand = self.runCfg.get('mpiCommand', 'ibrun')
                            walltime = self.runCfg.get('walltime', '00:30:00')
                            reservation = self.runCfg.get('reservation', None)
                            custom = self.runCfg.get('custom', '')
                            if reservation:
                                res = '#SBATCH --res=%s' % (reservation)
                            else:
                                res = ''

                            numproc = nodes * coresPerNode
                            command = '%s -np %d nrniv -python -mpi %s simConfig=%s netParams=%s' % (
                                mpiCommand, numproc, script, cfgSavePath,
                                netParamsSavePath)

                            jobString = """#!/bin/bash 
#SBATCH --job-name=%s
#SBATCH -A %s
#SBATCH -t %s
#SBATCH --nodes=%d
#SBATCH --ntasks-per-node=%d
#SBATCH -o %s.run
#SBATCH -e %s.err
#SBATCH --mail-user=%s
#SBATCH --mail-type=end
%s
%s

source ~/.bashrc
cd %s
%s
wait
                            """ % (simLabel, allocation, walltime, nodes,
                                   coresPerNode, jobName, jobName, email, res,
                                   custom, folder, command)

                            # Send job_string to qsub
                            print 'Submitting job ', jobName
                            print jobString + '\n'

                            batchfile = '%s.sbatch' % (jobName)
                            with open(batchfile, 'w') as text_file:
                                text_file.write("%s" % jobString)

                            #subprocess.call
                            proc = Popen(['sbatch', batchfile],
                                         stdin=PIPE,
                                         stdout=PIPE
                                         )  # Open a pipe to the qsub command.
                            (output, input) = (proc.stdin, proc.stdout)

                        # run mpi jobs directly e.g. if have 16 cores, can run 4 jobs * 4 cores in parallel
                        # eg. usage: python batch.py
                        elif self.runCfg.get('type', None) == 'mpi_direct':
                            jobName = self.saveFolder + '/' + simLabel
                            print 'Running job ', jobName
                            cores = self.runCfg.get('cores', 1)
                            folder = self.runCfg.get('folder', '.')
                            script = self.runCfg.get('script', 'init.py')
                            mpiCommand = self.runCfg.get('mpiCommand', 'ibrun')

                            command = '%s -np %d nrniv -python -mpi %s simConfig=%s netParams=%s' % (
                                mpiCommand, cores, script, cfgSavePath,
                                netParamsSavePath)

                            print command + '\n'
                            proc = Popen(command.split(' '),
                                         stdout=open(jobName + '.run', 'w'),
                                         stderr=open(jobName + '.err', 'w'))
                            #print proc.stdout.read()

                        # pc bulletin board job submission (master/slave) via mpi
                        # eg. usage: mpiexec -n 4 nrniv -mpi batch.py
                        elif self.runCfg.get('type', None) == 'mpi_bulletin':
                            jobName = self.saveFolder + '/' + simLabel
                            print 'Submitting job ', jobName
                            # master/slave bulletin board schedulling of jobs
                            pc.submit(runJob,
                                      self.runCfg.get('script', 'init.py'),
                                      cfgSavePath, netParamsSavePath)

                    sleep(1)  # avoid saturating scheduler
            print "-" * 80
            print "   Finished submitting jobs for grid parameter exploration   "
            print "-" * 80

        # -------------------------------------------------------------------------------
        # Evolutionary optimization
        # -------------------------------------------------------------------------------
        elif self.method == 'evol':
            import sys
            import inspyred.ec as EC

            # -------------------------------------------------------------------------------
            # Evolutionary optimization: Parallel evaluation
            # -------------------------------------------------------------------------------
            def evaluator(candidates, args):
                import os
                import signal
                global ngen
                ngen += 1
                total_jobs = 0

                # options slurm, mpi
                type = args.get('type', 'mpi_direct')

                # paths to required scripts
                script = args.get('script', 'init.py')
                netParamsSavePath = args.get('netParamsSavePath')
                genFolderPath = self.saveFolder + '/gen_' + str(ngen)

                # mpi command setup
                nodes = args.get('nodes', 1)
                paramLabels = args.get('paramLabels', [])
                coresPerNode = args.get('coresPerNode', 1)
                mpiCommand = args.get('mpiCommand', 'ibrun')
                numproc = nodes * coresPerNode

                # slurm setup
                custom = args.get('custom', '')
                folder = args.get('folder', '.')
                email = args.get('email', '[email protected]')
                walltime = args.get('walltime', '00:01:00')
                reservation = args.get('reservation', None)
                allocation = args.get('allocation', 'csd403')  # NSG account

                # fitness function
                fitnessFunc = args.get('fitnessFunc')
                fitnessFuncArgs = args.get('fitnessFuncArgs')
                defaultFitness = args.get('defaultFitness')

                # read params or set defaults
                sleepInterval = args.get('sleepInterval', 0.2)

                # create folder if it does not exist
                createFolder(genFolderPath)

                # remember pids and jobids in a list
                pids = []
                jobids = {}

                # create a job for each candidate
                for candidate_index, candidate in enumerate(candidates):
                    # required for slurm
                    sleep(sleepInterval)

                    # name and path
                    jobName = "gen_" + str(ngen) + "_cand_" + str(
                        candidate_index)
                    jobPath = genFolderPath + '/' + jobName

                    # modify cfg instance with candidate values
                    for label, value in zip(paramLabels, candidate):
                        self.setCfgNestedParam(label, value)
                        print 'set %s=%s' % (label, value)

                    #self.setCfgNestedParam("filename", jobPath)
                    self.cfg.simLabel = jobName
                    self.cfg.saveFolder = genFolderPath

                    # save cfg instance to file
                    cfgSavePath = jobPath + '_cfg.json'
                    self.cfg.save(cfgSavePath)

                    if type == 'mpi_bulletin':
                        # ----------------------------------------------------------------------
                        # MPI master-slaves
                        # ----------------------------------------------------------------------
                        pc.submit(runEvolJob, script, cfgSavePath,
                                  netParamsSavePath, jobPath)
                        print '-' * 80

                    else:
                        # ----------------------------------------------------------------------
                        # MPI job commnand
                        # ----------------------------------------------------------------------
                        command = '%s -np %d nrniv -python -mpi %s simConfig=%s netParams=%s ' % (
                            mpiCommand, numproc, script, cfgSavePath,
                            netParamsSavePath)

                        # ----------------------------------------------------------------------
                        # run on local machine with <nodes*coresPerNode> cores
                        # ----------------------------------------------------------------------
                        if type == 'mpi_direct':
                            executer = '/bin/bash'
                            jobString = bashTemplate('mpi_direct') % (
                                custom, folder, command)

                        # ----------------------------------------------------------------------
                        # run on HPC through slurm
                        # ----------------------------------------------------------------------
                        elif type == 'hpc_slurm':
                            executer = 'sbatch'
                            res = '#SBATCH --res=%s' % (
                                reservation) if reservation else ''
                            jobString = bashTemplate('hpc_slurm') % (
                                jobName, allocation, walltime, nodes,
                                coresPerNode, jobPath, jobPath, email, res,
                                custom, folder, command)

                        # ----------------------------------------------------------------------
                        # run on HPC through PBS
                        # ----------------------------------------------------------------------
                        elif type == 'hpc_torque':
                            executer = 'qsub'
                            queueName = args.get('queueName', 'default')
                            nodesppn = 'nodes=%d:ppn=%d' % (nodes,
                                                            coresPerNode)
                            jobString = bashTemplate('hpc_torque') % (
                                jobName, walltime, queueName, nodesppn,
                                jobPath, jobPath, custom, command)

                        # ----------------------------------------------------------------------
                        # save job and run
                        # ----------------------------------------------------------------------
                        print 'Submitting job ', jobName
                        print jobString
                        print '-' * 80
                        # save file
                        batchfile = '%s.sbatch' % (jobPath)
                        with open(batchfile, 'w') as text_file:
                            text_file.write("%s" % jobString)

                        #with open(jobPath+'.run', 'a+') as outf, open(jobPath+'.err', 'w') as errf:
                        with open(jobPath + '.jobid',
                                  'w') as outf, open(jobPath + '.err',
                                                     'w') as errf:
                            pids.append(
                                Popen([executer, batchfile],
                                      stdout=outf,
                                      stderr=errf,
                                      preexec_fn=os.setsid).pid)
                        #proc = Popen(command.split([executer, batchfile]), stdout=PIPE, stderr=PIPE)
                        sleep(0.1)
                        #read = proc.stdout.read()
                        with open(jobPath + '.jobid', 'r') as outf:
                            read = outf.readline()
                        print read
                        if len(read) > 0:
                            jobid = int(read.split()[-1])
                            jobids[candidate_index] = jobid
                        print 'jobids', jobids
                    total_jobs += 1
                    sleep(0.1)

                # ----------------------------------------------------------------------
                # gather data and compute fitness
                # ----------------------------------------------------------------------
                if type == 'mpi_bulletin':
                    # wait for pc bulletin board jobs to finish
                    try:
                        while pc.working():
                            sleep(1)
                        #pc.done()
                    except:
                        pass

                num_iters = 0
                jobs_completed = 0
                fitness = [None for cand in candidates]
                # print outfilestem
                print "Waiting for jobs from generation %d/%d ..." % (
                    ngen, args.get('max_generations'))
                # print "PID's: %r" %(pids)
                # start fitness calculation
                while jobs_completed < total_jobs:
                    unfinished = [
                        i for i, x in enumerate(fitness) if x is None
                    ]
                    for candidate_index in unfinished:
                        try:  # load simData and evaluate fitness
                            jobNamePath = genFolderPath + "/gen_" + str(
                                ngen) + "_cand_" + str(candidate_index)
                            if os.path.isfile(jobNamePath + '.json'):
                                with open('%s.json' % (jobNamePath)) as file:
                                    simData = json.load(file)['simData']
                                fitness[candidate_index] = fitnessFunc(
                                    simData, **fitnessFuncArgs)
                                jobs_completed += 1
                                print '  Candidate %d fitness = %.1f' % (
                                    candidate_index, fitness[candidate_index])
                        except Exception as e:
                            # print
                            err = "There was an exception evaluating candidate %d:" % (
                                candidate_index)
                            print("%s \n %s" % (err, e))
                            #pass
                            #print 'Error evaluating fitness of candidate %d'%(candidate_index)
                    num_iters += 1
                    print 'completed: %d' % (jobs_completed)
                    if num_iters >= args.get('maxiter_wait', 5000):
                        print "Max iterations reached, the %d unfinished jobs will be canceled and set to default fitness" % (
                            len(unfinished))
                        for canditade_index in unfinished:
                            fitness[canditade_index] = defaultFitness
                            jobs_completed += 1
                            if 'scancelUser' in kwargs:
                                os.system('scancel -u %s' %
                                          (kwargs['scancelUser']))
                            else:
                                os.system(
                                    'scancel %d' % (jobids[candidate_index])
                                )  # terminate unfinished job (resubmitted jobs not terminated!)
                    sleep(args.get('time_sleep', 1))

                # kill all processes
                if type == 'mpi_bulletin':
                    try:
                        with open("./pids.pid",
                                  'r') as file:  # read pids for mpi_bulletin
                            pids = [
                                int(i) for i in file.read().split(' ')[:-1]
                            ]

                        with open("./pids.pid", 'w') as file:  # delete content
                            pass
                        for pid in pids:
                            try:
                                os.killpg(os.getpgid(pid), signal.SIGTERM)
                            except:
                                pass
                    except:
                        pass
                # don't want to to this for hpcs since jobs are running on compute nodes not master
                # else:
                #     try:
                #         for pid in pids: os.killpg(os.getpgid(pid), signal.SIGTERM)
                #     except:
                #         pass
                # return
                print "-" * 80
                print "  Completed a generation  "
                print "-" * 80
                return fitness

            # -------------------------------------------------------------------------------
            # Evolutionary optimization: Generation of first population candidates
            # -------------------------------------------------------------------------------
            def generator(random, args):
                # generate initial values for candidates
                return [
                    random.uniform(l, u) for l, u in zip(
                        args.get('lower_bound'), args.get('upper_bound'))
                ]

            # -------------------------------------------------------------------------------
            # Mutator
            # -------------------------------------------------------------------------------
            @EC.variators.mutator
            def nonuniform_bounds_mutation(random, candidate, args):
                """Return the mutants produced by nonuniform mutation on the candidates.
                .. Arguments:
                   random -- the random number generator object
                   candidate -- the candidate solution
                   args -- a dictionary of keyword arguments
                Required keyword arguments in args:
                Optional keyword arguments in args:
                - *mutation_strength* -- the strength of the mutation, where higher
                  values correspond to greater variation (default 1)
                """
                lower_bound = args.get('lower_bound')
                upper_bound = args.get('upper_bound')
                strength = args.setdefault('mutation_strength', 1)
                mutant = copy(candidate)
                for i, (c, lo, hi) in enumerate(
                        zip(candidate, lower_bound, upper_bound)):
                    if random.random() <= 0.5:
                        new_value = c + (hi - c) * (1.0 -
                                                    random.random()**strength)
                    else:
                        new_value = c - (c - lo) * (1.0 -
                                                    random.random()**strength)
                    mutant[i] = new_value

                return mutant

            # -------------------------------------------------------------------------------
            # Evolutionary optimization: Main code
            # -------------------------------------------------------------------------------
            import os
            # create main sim directory and save scripts
            self.saveScripts()

            global ngen
            ngen = -1

            # log for simulation
            logger = logging.getLogger('inspyred.ec')
            logger.setLevel(logging.DEBUG)
            file_handler = logging.FileHandler(self.saveFolder +
                                               '/inspyred.log',
                                               mode='a')
            file_handler.setLevel(logging.DEBUG)
            formatter = logging.Formatter(
                '%(asctime)s - %(name)s - %(levelname)s - %(message)s')
            file_handler.setFormatter(formatter)
            logger.addHandler(file_handler)

            # create randomizer instance
            rand = Random()
            rand.seed(self.seed)

            # create file handlers for observers
            stats_file, ind_stats_file = self.openFiles2SaveStats()

            # gather **kwargs
            kwargs = {'cfg': self.cfg}
            kwargs['num_inputs'] = len(self.params)
            kwargs['paramLabels'] = [x['label'] for x in self.params]
            kwargs['lower_bound'] = [x['values'][0] for x in self.params]
            kwargs['upper_bound'] = [x['values'][1] for x in self.params]
            kwargs['statistics_file'] = stats_file
            kwargs['individuals_file'] = ind_stats_file
            kwargs[
                'netParamsSavePath'] = self.saveFolder + '/' + self.batchLabel + '_netParams.py'

            for key, value in self.evolCfg.iteritems():
                kwargs[key] = value
            if not 'maximize' in kwargs: kwargs['maximize'] = False

            for key, value in self.runCfg.iteritems():
                kwargs[key] = value

            # if using pc bulletin board, initialize all workers
            if self.runCfg.get('type', None) == 'mpi_bulletin':
                for iworker in range(int(pc.nhost())):
                    pc.runworker()

            ####################################################################
            #                       Evolution strategy
            ####################################################################
            # Custom algorithm based on Krichmar's params
            if self.evolCfg['evolAlgorithm'] == 'krichmarCustom':
                ea = EC.EvolutionaryComputation(rand)
                ea.selector = EC.selectors.tournament_selection
                ea.variator = [
                    EC.variators.uniform_crossover, nonuniform_bounds_mutation
                ]
                ea.replacer = EC.replacers.generational_replacement
                if not 'tournament_size' in kwargs:
                    kwargs['tournament_size'] = 2
                if not 'num_selected' in kwargs:
                    kwargs['num_selected'] = kwargs['pop_size']

            # Genetic
            elif self.evolCfg['evolAlgorithm'] == 'genetic':
                ea = EC.GA(rand)

            # Evolution Strategy
            elif self.evolCfg['evolAlgorithm'] == 'evolutionStrategy':
                ea = EC.ES(rand)

            # Simulated Annealing
            elif self.evolCfg['evolAlgorithm'] == 'simulatedAnnealing':
                ea = EC.SA(rand)

            # Differential Evolution
            elif self.evolCfg['evolAlgorithm'] == 'diffEvolution':
                ea = EC.DEA(rand)

            # Estimation of Distribution
            elif self.evolCfg['evolAlgorithm'] == 'estimationDist':
                ea = EC.EDA(rand)

            # Particle Swarm optimization
            elif self.evolCfg['evolAlgorithm'] == 'particleSwarm':
                from inspyred import swarm
                ea = swarm.PSO(rand)
                ea.topology = swarm.topologies.ring_topology

            # Ant colony optimization (requires components)
            elif self.evolCfg['evolAlgorithm'] == 'antColony':
                from inspyred import swarm
                ea = swarm.ACS(rand)
                ea.topology = swarm.topologies.ring_topology

            else:
                raise ValueError("%s is not a valid strategy" %
                                 (self.evolCfg['evolAlgorithm']))
            ####################################################################
            ea.terminator = EC.terminators.generation_termination
            ea.observer = [
                EC.observers.stats_observer, EC.observers.file_observer
            ]
            # -------------------------------------------------------------------------------
            # Run algorithm
            # -------------------------------------------------------------------------------
            final_pop = ea.evolve(generator=generator,
                                  evaluator=evaluator,
                                  bounder=EC.Bounder(kwargs['lower_bound'],
                                                     kwargs['upper_bound']),
                                  logger=logger,
                                  **kwargs)

            # close file
            stats_file.close()
            ind_stats_file.close()

            # print best and finish
            print('Best Solution: \n{0}'.format(str(max(final_pop))))
            print "-" * 80
            print "   Completed evolutionary algorithm parameter optimization   "
            print "-" * 80
            sys.exit()
Example #5
0
            selected.append(max(tournament))
        else:
            cons = [constraint_func(t.candidate) for t in tournament]
            # If no constraints are violated, just do
            # regular tournament selection.
            if max(cons) == 0:
                selected.append(max(tournament))
            # Otherwise, choose the least violator
            # (which may be a non-violator).
            else:
                selected.append(tournament[cons.index(min(cons))])
    return selected


r = random.Random()
myec = ec.EvolutionaryComputation(r)
myec.selector = constrained_tournament_selection
myec.variator = variators.gaussian_mutation
myec.replacer = replacers.generational_replacement
myec.terminator = terminators.evaluation_termination
myec.observer = observers.stats_observer
pop = myec.evolve(my_generator,
                  my_evaluator,
                  pop_size=100,
                  bounder=ec.Bounder(-2, 2),
                  num_selected=100,
                  constraint_func=my_constraint_function,
                  mutation_rate=0.5,
                  max_evaluations=2000)

import matplotlib.pyplot as plt
def run_optimization(optimProbConf,
                     resultFile=None,
                     isMultiProc=False,
                     population=None):
    """
    Function to perform the optimization using the integer set representation to the candidates solutions.

    Args:
    optimProbConf (OptimProblemConfiguration): This object contains all
        information to perform the strain optimization task.
    resultFile (str): The path file to store all the results obtained during
        the optimization (default results are not saved into a file)
    isMultiProc (bool): True, if the user wants parallelize the population evaluation. (default False)

    Returns
        list: the individuals of the last population.

    """

    rand = Random()
    ea = ec.EvolutionaryComputation(rand)
    ea.selector = ec.selectors.tournament_selection
    ea.replacer = replacers.new_candidates_no_duplicates_replacement
    ea.terminator = ec.terminators.generation_termination

    if resultFile is not None:
        ea.observer = observers.save_all_results

    if optimProbConf.type in [
            optimType.REACTION_KO, optimType.GENE_KO, optimType.MEDIUM,
            optimType.PROTEIN_KO
    ]:
        # int set representation
        bounds = [0, len(optimProbConf.get_decoder().ids) - 1]
        myGenerator = generators.generator_single_int_set
        ea.variator = [
            variators.uniform_crossover, variators.grow_mutation_intSetRep,
            variators.shrink_mutation, variators.single_mutation_intSetRep
        ]
    elif optimProbConf.type == optimType.MEDIUM_REACTION_KO:
        bounds = [[0, 0],
                  [
                      len(optimProbConf.get_decoder().drains) - 1,
                      len(optimProbConf.get_decoder().reactions) - 1
                  ]]
        myGenerator = generators.generator_tuple_int_set
        ea.variator = [
            variators.uniform_crossover_tuple,
            variators.grow_mutation_tuple_intSetRep,
            variators.shrink_mutation_tuple,
            variators.single_mutation_tuple_intSetRep
        ]
    else:
        # tuple set representation
        bounds = [[0, 0],
                  [
                      len(optimProbConf.get_decoder().ids) - 1,
                      len(optimProbConf.get_decoder().levels) - 1
                  ]]
        myGenerator = generators.generator_single_int_tuple
        ea.variator = [
            variators.uniform_crossover_intTupleRep,
            variators.grow_mutation_intTupleRep, variators.shrink_mutation,
            variators.single_mutation_intTupleRep
        ]

    config = optimProbConf.get_ea_configurations()

    if isMultiProc:
        try:
            nprocs = int(cpu_count() / 2)
        except NotImplementedError:
            nprocs = config.NUM_CPUS
        print("number of proc", nprocs)
        final_pop = ea.evolve(generator=myGenerator,
                              evaluator=evaluators.parallel_evaluation_mp,
                              mp_evaluator=evaluators.evaluator,
                              mp_nprocs=nprocs,
                              pop_size=config.POPULATION_SIZE,
                              bounder=ec.Bounder(bounds[0], bounds[1]),
                              max_generations=config.MAX_GENERATIONS,
                              candidate_max_size=config.MAX_CANDIDATE_SIZE,
                              num_elites=config.NUM_ELITES,
                              num_selected=config.POPULATION_SELECTED_SIZE,
                              crossover_rate=config.CROSSOVER_RATE,
                              mutation_rate=config.MUTATION_RATE,
                              new_candidates_rate=config.NEW_CANDIDATES_RATE,
                              configuration=optimProbConf,
                              results_file=resultFile,
                              tournament_size=config.TOURNAMENT_SIZE,
                              seeds=population)
    else:
        final_pop = ea.evolve(generator=myGenerator,
                              evaluator=evaluators.evaluator,
                              bounder=ec.Bounder(bounds[0], bounds[1]),
                              pop_size=config.POPULATION_SIZE,
                              max_generations=config.MAX_GENERATIONS,
                              candidate_max_size=config.MAX_CANDIDATE_SIZE,
                              num_elites=config.NUM_ELITES,
                              num_selected=config.POPULATION_SELECTED_SIZE,
                              crossover_rate=config.CROSSOVER_RATE,
                              mutation_rate=config.MUTATION_RATE,
                              new_candidates_rate=config.NEW_CANDIDATES_RATE,
                              configuration=optimProbConf,
                              results_file=resultFile,
                              tournament_size=config.TOURNAMENT_SIZE,
                              seeds=population)
    return final_pop
Example #7
0
#main

# create random seed for evolutionary computation algorithm --> my_ec = ec.EvolutionaryComputation(rand)
rand = Random()
rand.seed(1)

# target mean firing rate in Hz for comparison
targetFiring = 20

# min and max allowed value for each param optimized:
#                 na11a, na12, na13, na16, KDRI
minParamValues = [0.005, 0.005, 0.005, 0.005, 0.02]
maxParamValues = [10, 10, 10, 10, 40]

# instantiate evolutionary computation algorithm with random seed
my_ec = ec.EvolutionaryComputation(rand)

# establish parameters for the evolutionary computation algorithm, additional documentation can be found @ pythonhosted.org/inspyred/reference.html
my_ec.selector = ec.selectors.tournament_selection  # tournament sampling of individuals from population (<num_selected> individuals are chosen based on best fitness performance in tournament)

#toggle variators
my_ec.variator = [
    ec.variators.
    uniform_crossover,  # biased coin flip to determine whether 'mom' or 'dad' element is passed to offspring design
    ec.variators.gaussian_mutation
]  # gaussian mutation which makes use of bounder function as specified in --> my_ec.evolve(...,bounder=ec.BOunder(minParamValues, maxParamValues),...)

my_ec.replacer = ec.replacers.generational_replacement  # existing generation is replaced by offspring, with elitism (<num_elites> existing individuals will survive if they have better fitness than offspring)

my_ec.terminator = ec.terminators.evaluation_termination  # termination dictated by number of evaluations that have been run
Example #8
0
    def optimize(self, do_plot=True, seed=int(time()), summary_dir=None):

        rand = Random()
        rand.seed(seed)

        if summary_dir is None:
            cwd = os.getcwd()
            summary_dir = os.path.dirname(cwd) + '/data/'

        if not os.path.exists(summary_dir):
            os.mkdir(summary_dir)

        stat_file_name = summary_dir + '/ga_statistics.csv'
        ind_file_name = summary_dir + '/ga_individuals.csv'

        stat_file = open(stat_file_name, 'w')
        ind_file = open(ind_file_name, 'w')
        print("Created files: %s and %s" % (stat_file_name, ind_file_name))

        if self.verbose:
            logger = logging.getLogger('inspyred.ec')
            logger.setLevel(logging.DEBUG)

            ch = logging.StreamHandler()
            # ch.setLevel(logging.DEBUG)
            formatter = logging.Formatter(
                '>>> EC: - %(levelname)s - %(message)s')
            ch.setFormatter(formatter)
            logger.addHandler(ch)

        algorithm = ec.EvolutionaryComputation(rand)
        algorithm.observer = observers.file_observer
        algorithm.terminator = terminators.evaluation_termination
        algorithm.selector = selectors.tournament_selection
        algorithm.replacer = replacers.steady_state_replacement
        algorithm.variator = [
            variators.blend_crossover, variators.gaussian_mutation
        ]

        final_pop = algorithm.evolve(generator=self.uniform_random_chromosome,
                                     evaluator=self.evaluator.evaluate,
                                     pop_size=self.population_size,
                                     maximize=self.maximize,
                                     bounder=ec.Bounder(
                                         lower_bound=self.min_constraints,
                                         upper_bound=self.max_constraints),
                                     num_selected=self.num_selected,
                                     tourn_size=self.tourn_size,
                                     num_elites=self.num_elites,
                                     num_offspring=self.num_offspring,
                                     max_evaluations=self.max_evaluations,
                                     mutation_rate=self.mutation_rate,
                                     statistics_file=stat_file,
                                     seeds=self.seeds,
                                     individuals_file=ind_file)

        stat_file.close()
        ind_file.close()

        self.print_report(final_pop, do_plot, stat_file_name)

        #return the parameter set for the best individual

        return final_pop[0].candidate, final_pop[0].fitness

def plus_replacement(random, population, parents, offspring, args):
    pool = list(offspring)
    pool.extend(population)
    pool.sort(reverse=True)
    survivors = pool[:len(population)]
    return survivors


#Fixe le générateur de nombre aléatoire
prng = Random()
prng.seed(time())

# Création et paramétrisation de l'algorithme évolutionnaire
ea = ec.EvolutionaryComputation(prng)
ea.selector = ec.selectors.tournament_selection  # Choix de la fonction de selection
ea.variator = [
    ec.variators.blend_crossover,  #Choix de la fonction de crossover
    ec.variators.gaussian_mutation
]  # Choix de la fonction de mutation
ea.replacer = plus_replacement  #Choix de la fonction de remplacement générationnel
ea.terminator = ec.terminators.generation_termination  # Choix de la fonction qui arrête l'algorithme
ea.observer = [ec.observers.stats_observer, ec.observers.file_observer
               ]  #Permet de récolter des statistiques à chaque génération
popsize = 20  #Taille de la population
nVar = 1  # Nombre de dimension du problème
maxIt = 100
minBound = np.repeat(0, nVar)  # Bornes min
maxBound = np.repeat(1, nVar)  # Bornes max
statsFile = open('stats_pop.csv', 'w')