Beispiel #1
0
    def simulate(self, n_steps):

        # set up initial system from optimized system
        current_system = System(self.opt_systems[-1].particles,
                                self.parameters)
        # pass particle positions and neighbourlist to the energy calculator class
        self.energy_calculator.set_system(
            current_system.neighbourlist.particle_positions,
            current_system.neighbourlist.cell_list,
            current_system.neighbourlist.particle_neighbour_list)
        # calculate energy of initial system
        current_system.energy = self._calculate_overall_energy()
        # append to trajectory
        self.sim_systems.append(current_system)

        for i in range(n_steps):

            # generate trial system
            trial_system = MetropolisMonteCarlo.generate_trial_configuration(
                self.sim_systems[-1], self.parameters)

            # update particle positions and neighbourlist
            self.energy_calculator.set_system(
                trial_system.neighbourlist.particle_positions,
                trial_system.neighbourlist.cell_list,
                trial_system.neighbourlist.particle_neighbour_list)

            # calculate energy of trial system
            trial_system.energy = self._calculate_overall_energy()

            # evaluate system and trial system and append the accepted system to the trajectory
            self.sim_systems.append(
                MetropolisMonteCarlo.evaluate_trial_configuration(
                    self.sim_systems[-1], trial_system, self.parameters))
Beispiel #2
0
    def test_shift_position(self):
        particle_type = ParticleType(name="Hydrogen",
                                     mass=1.008,
                                     charge=1.602,
                                     lj_epsilon=0.21,
                                     lj_sigma=2.5)
        particle_type = np.array([particle_type])

        parameters = Parameters(temperature=0,
                                box=np.array([12., 13., 14.]),
                                es_sigma=0.5,
                                update_radius=1,
                                particle_types=particle_type,
                                cutoff_radius=3,
                                K_cutoff=1)
        reference_pos1 = np.array([1.5, 1.0, 1.5])
        reference_pos2 = np.array([10.5, 12.0, 5.5])
        particle_position_1 = np.array([13.5, 14., 15.5])
        shifted_position_1 = MetropolisMonteCarlo._shift_position(
            particle_position_1, parameters)
        particle_position_2 = np.array([-1.5, -1., 5.5])
        shifted_position_2 = MetropolisMonteCarlo._shift_position(
            particle_position_2, parameters)
        npt.assert_equal(reference_pos1,
                         shifted_position_1,
                         'Failed',
                         verbose=True)
        npt.assert_equal(reference_pos2,
                         shifted_position_2,
                         'Failed',
                         verbose=True)
Beispiel #3
0
    def optimize(self, n_steps):

        # set up initial system
        current_system = System(self.system.particles, self.parameters)
        # pass particle positions and neighbourlist to the energy calculator class
        self.energy_calculator.set_system(
            current_system.neighbourlist.particle_positions,
            current_system.neighbourlist.cell_list,
            current_system.neighbourlist.particle_neighbour_list)
        # calculate energy of initial system
        current_system.energy = self._calculate_overall_energy()
        # append to optimize trajectory
        self.opt_systems.append(current_system)

        # crude optimization
        for i in range(n_steps):
            # generate trial system
            trial_system = MetropolisMonteCarlo.generate_trial_configuration(
                self.opt_systems[-1], self.parameters)

            # update particle positions and neighbourlist
            self.energy_calculator.set_system(
                trial_system.neighbourlist.particle_positions,
                trial_system.neighbourlist.cell_list,
                trial_system.neighbourlist.particle_neighbour_list)

            # calculate energy of trial system
            trial_system.energy = self._calculate_overall_energy()

            # evaluate system and trial system and append the accepted system to the trajectory
            self.opt_systems.append(
                MetropolisMonteCarlo.evaluate_trial_configuration_greedy(
                    self.opt_systems[-1], trial_system))

        # interim update_radius
        update_radius = self.parameters.update_radius
        self.parameters.update_radius = update_radius / 10

        # fine optimization
        for i in range(100):
            # generate trial system
            trial_system = MetropolisMonteCarlo.generate_trial_configuration(
                self.opt_systems[-1], self.parameters)

            # update particle positions and neighbourlist
            self.energy_calculator.set_system(
                trial_system.neighbourlist.particle_positions,
                trial_system.neighbourlist.cell_list,
                trial_system.neighbourlist.particle_neighbour_list)

            # calculate energy of trial system
            trial_system.energy = self._calculate_overall_energy()

            # evaluate system and trial system and append the accepted system to the trajectory
            self.opt_systems.append(
                MetropolisMonteCarlo.evaluate_trial_configuration_greedy(
                    self.opt_systems[-1], trial_system))

        # resetting update_radius to desired value
        self.parameters.update_radius = update_radius
Beispiel #4
0
 def test__generate_trial_position_redundancy(self):
     particle_type = ParticleType(name="Natrium",
                                  mass=2,
                                  charge=2,
                                  lj_epsilon=1.25,
                                  lj_sigma=0.5)
     particle_type = np.array([particle_type])
     parameters = Parameters(temperature=0,
                             box=np.array([12., 13., 14.]),
                             es_sigma=0.5,
                             update_radius=1,
                             particle_types=particle_type,
                             cutoff_radius=0.5,
                             K_cutoff=1)
     particle_1 = Particle(position=np.array([1, 2, 3]), type_index=0)
     particle_2 = Particle(position=np.array([1, 2, 3]), type_index=0)
     trial_position1 = np.array(
         MetropolisMonteCarlo._generate_trial_position(
             particle_1.position, parameters))
     trial_position2 = np.array(
         MetropolisMonteCarlo._generate_trial_position(
             particle_1.position, parameters))
     x = 0
     if np.array_equal(trial_position1, trial_position2):
         x = 1
     else:
         x = 2
     npt.assert_equal(x, 2, 'Failed', verbose=True)
    def simulate(self, n_steps):
        raise NotImplementedError()

        current_system = System(self.system.particles, self.parameters)
        current_system.energy = calculate_energy()  # not implemented yet
        self.sim_systems.append(current_system)

        for i in range(n_steps):
            trial_system = MetropolisMonteCarlo.generate_trial_configuration(
                self.sim_systems[-1], self.parameters)
            trial_system.energy = calculate_energy()  # not implemented yet
            self.sim_systems.append(
                MetropolisMonteCarlo.evaluate_trial_configuration(
                    self.sim_systems[-1], trial_system))
    def optimize(self, n_steps):
        raise NotImplementedError()

        current_system = System(self.system.particles, self.parameters)
        current_system.energy = calculate_energy()  # not implemented yet

        for i in range(n_steps):
            trial_system = MetropolisMonteCarlo.generate_trial_configuration(
                current_system, self.parameters)
            trial_system.energy = calculate_energy()  # not implemented yet
            current_system = MetropolisMonteCarlo.evaluate_trial_configuration_greedy(
                current_system, trial_system)

        self.opt_system = current_system
Beispiel #7
0
    def test_evaluate_trial_configuration_greedy_3(self):

        # set test parameters
        charges = np.ones(10).astype(np.float32)
        lj_sigmas = np.ones(10).astype(np.float32)
        lj_epsilons = np.ones(10).astype(np.float32)

        para = Parameters(temperature=1,
                          box=np.array([1, 1, 1]),
                          es_sigma=1,
                          update_radius=1,
                          charges=charges,
                          lj_sigmas=lj_sigmas,
                          lj_epsilons=lj_epsilons,
                          update_probability=0.5,
                          accuracy=1)

        particle1 = Particle(np.array([0.5, 0.5, 0.5]))
        particle2 = Particle(np.array([0.5, 0.5, 0.1]))
        particles = [particle1, particle2]

        system = System(particles=particles, parameters=para)
        system.energy.overall_energy = 1.1
        trial_system = System(particles=particles, parameters=para)
        trial_system.energy.overall_energy = 1

        actual = MetropolisMonteCarlo.evaluate_trial_configuration_greedy(
            system, trial_system)

        npt.assert_equal(actual, trial_system)
Beispiel #8
0
    def test_generate_trial_position_2(self):

        position = np.array([0.5, 0.5, 0.5])

        # set test parameters
        charges = np.ones(10).astype(np.float32)
        lj_sigmas = np.ones(10).astype(np.float32)
        lj_epsilons = np.ones(10).astype(np.float32)

        para = Parameters(temperature=1,
                          box=np.array([1, 1, 1]),
                          es_sigma=1,
                          update_radius=1,
                          charges=charges,
                          lj_sigmas=lj_sigmas,
                          lj_epsilons=lj_epsilons,
                          update_probability=0.5,
                          accuracy=1)

        distances = []
        for i in range(10000):
            trial_position = MetropolisMonteCarlo._generate_trial_position(
                position, para)
            distances.append(np.linalg.norm(position - trial_position))

        distances = np.array(distances)
        npt.assert_approx_equal(distances.sum() / 10000, 0.5, significant=2)
Beispiel #9
0
    def test_generate_trial_position_1(self):

        position = np.array([0.5, 0.5, 0.5])

        # set test parameters
        charges = np.ones(10).astype(np.float32)
        lj_sigmas = np.ones(10).astype(np.float32)
        lj_epsilons = np.ones(10).astype(np.float32)

        para = Parameters(temperature=1,
                          box=np.array([1, 1, 1]),
                          es_sigma=1,
                          update_radius=1,
                          charges=charges,
                          lj_sigmas=lj_sigmas,
                          lj_epsilons=lj_epsilons,
                          update_probability=0.5,
                          accuracy=1)

        for i in range(1000):
            trial_position = MetropolisMonteCarlo._generate_trial_position(
                position, para)
            distance = np.linalg.norm(position - trial_position)
            if distance > para.update_radius:
                raise AssertionError("Distance greater than update radius")
Beispiel #10
0
 def test__generate_trial_position_3(self):
     particle_type = ParticleType(name="Hydrogen",
                                  mass=1.008,
                                  charge=1.602,
                                  lj_epsilon=0.21,
                                  lj_sigma=2.5)
     particle_type = np.array([particle_type])
     parameters = Parameters(temperature=0,
                             box=np.array([12., 13., 13.]),
                             es_sigma=0.5,
                             update_radius=1,
                             particle_types=particle_type,
                             cutoff_radius=0.5)
     particle_1 = Particle(position=np.array([1, 2, 4]), type_index=1)
     trial_position1 = np.array(
         MetropolisMonteCarlo._generate_trial_position(
             particle_1.position, parameters))
    def test_shift_position_1(self):

        position = np.array([0.5, 0.5, 0.5])

        # set test parameters
        charges = np.ones(10).astype(np.float32)
        lj_sigmas = np.ones(10).astype(np.float32)
        lj_epsilons = np.ones(10).astype(np.float32)

        para = Parameters(temperature=1,
                          box=np.array([1, 1, 1]),
                          update_radius=1,
                          charges=charges,
                          lj_sigmas=lj_sigmas,
                          lj_epsilons=lj_epsilons,
                          update_probability=0.5,
                          accuracy=1)

        actual = MetropolisMonteCarlo._shift_position(position, para)

        npt.assert_array_equal(actual, position)
Beispiel #12
0
    def test_shift_position_4(self):

        position = np.array([-1.3, 2.4, -3.4])

        # set test parameters
        charges = np.ones(10).astype(np.float32)
        lj_sigmas = np.ones(10).astype(np.float32)
        lj_epsilons = np.ones(10).astype(np.float32)

        para = Parameters(temperature=1,
                          box=np.array([1, 1, 1]),
                          es_sigma=1,
                          update_radius=1,
                          charges=charges,
                          lj_sigmas=lj_sigmas,
                          lj_epsilons=lj_epsilons,
                          update_probability=0.5,
                          accuracy=1)

        actual = MetropolisMonteCarlo._shift_position(position, para)
        reference = np.array([0.7, 0.4, 0.6])

        npt.assert_array_almost_equal(actual, reference)