Sei sulla pagina 1di 11

358 IEEE TRANSACTIONS ON SYSTEMS, MAN, AND CYBERNETICS—PART A: SYSTEMS AND HUMANS, VOL. 38, NO.

2, MARCH 2008

An Effective PSO and AIS-Based Hybrid Intelligent


Algorithm for Job-Shop Scheduling
Hong-Wei Ge, Liang Sun, Yan-Chun Liang, and Feng Qian

Abstract—The optimization of job-shop scheduling is very im- can be solved within a reasonable computational time by exact
portant because of its theoretical and practical significance. In this optimization algorithms such as branch and bound [1], [2]
paper, a computationally effective algorithm of combining PSO and dynamic programming [3], [4], including the notorious
with AIS for solving the minimum makespan problem of job-shop
scheduling is proposed. In the particle swarm system, a novel 10 × 10 instance of Fisher and Thompson, which was proposed
concept for the distance and velocity of a particle is presented in 1963 and only solved 20 years later. Problems of dimension
to pave the way for the job-shop scheduling problem. In the 15 × 15 are still considered to be beyond the reach of today’s
artificial immune system, the models of vaccination and receptor exact methods. By contrast, approximate and heuristic methods
editing are designed to improve the immune performance. The make a tradeoff between solution quality and computational
proposed algorithm effectively exploits the capabilities of distrib-
uted and parallel computing of swarm intelligence approaches. cost. These methods mainly include dispatching priority rules
The algorithm is examined by using a set of benchmark instances [5]–[7], shifting bottleneck approach [8], [9], Lagrangian re-
with various sizes and levels of hardness and is compared with laxation [10], [11], and tabu search [12]–[14] and have made
other approaches reported in some existing literature works. The considerable achievement. In recent years, much attention has
computational results validate the effectiveness of the proposed been devoted to metaheuristics with the emergence of new tech-
approach.
niques from the field of artificial intelligence such as genetic
Index Terms—Artificial immune system (AIS), artificial intelli- algorithm (GA) [15]–[18], simulated annealing [19]–[22], ant
gence, job-shop scheduling problem (JSSP), particle swarm opti- colony optimization [23], particle swarm optimization (PSO)
mization (PSO), vaccination.
[24], [25], artificial neural network [26]–[28], artificial immune
system (AIS) [29], and so on. These metaheuristics can be re-
I. I NTRODUCTION garded as problem-independent approaches and are well suited
to solve complex problems that may be difficult to solve by
T HE JOB-SHOP scheduling problem (JSSP) is a very
important practical problem in both fields of production
management and combinatorial optimization. Efficient methods
traditional techniques. Moreover, they are capable of producing
high-quality solutions with reasonable computational effort.
for solving the JSSP have significant effects on profitability Among the metaheuristic algorithms, GA has been used with
and product quality. The JSSP has drawn the attention of increasing frequency to address scheduling problems and may
researchers for the last three decades, but because scheduling not remain to have much room for improvement. However, the
problems vary widely according to specific production tasks use of PSO and AIS for the solution of scheduling problems has
and most of them are strongly nondeterministic polynomial- been scarce, specifically the PSO. In addition, many research
time hard problems, some test problems of moderate size are results of the JSSP show that it is difficult to obtain a good-
still unsolved. In fact, only small-size instances of the problems enough solution only by single search scheme. Motivated by
these perspectives, we propose a novel hybrid intelligent algo-
rithm for the JSSP based on the PSO and AIS in this paper.
Manuscript received September 22, 2005; revised August 2, 2006. This
work was supported by the National Outstanding Youth Science Fund
Both PSO and AIS are evolutionary computation techniques
(60625302), by the National “973” Plan (2002CB3122000), by the National based on swarm intelligence. They exhibit implicit parallelism
“863” Plan (20060104Z1081), by the National Natural Science Founda- and contain certain redundancy and historical information of
tion of China (60673023 and 60433020), by the Science–Technology De-
velopment Project of Jilin Province of China (20050705-2), by the “985”
past solutions. Therefore, the proposed hybrid algorithm also
Project of Jilin University of China, and by the European Commission un- effectively exploits the capabilities of distributed and parallel
der Grant TH/Asia Link/010 (111084). This paper was recommended by computing of swarm intelligence approaches.
Associate Editor B. Veeravalli.
H.-W. Ge was with Jilin University, Changchun 130012, China. He is now
The remainder of the paper is organized as follows. Section II
with the School of Information Science and Engineering, East China Univer- introduces and formulates the JSSP. Section III describes the
sity of Science and Technology, Shanghai 200237, China (e-mail: art21cn@ proper representation for the problem and proposes a schedule
ecust.edu.cn).
L. Sun is with the College of Computer Science and Technology, Jilin
initialization algorithm based on the Giffler and Thompson
University, Changchun 130012, China (e-mail: sliang@email.jlu.edu.cn). (G&T) algorithm. PSO- and AIS-based scheduling algorithms
Y.-C. Liang is with the College of Computer Science and Technology, Jilin are proposed in Sections IV and V, respectively, which are
University, Changchun 130012, China, and also with the Institute of High
Performance Computing, Singapore 117528 (e-mail: ycliang@jlu.edu.cn). followed by Section VI that shows the framework of the
F. Qian is with the Automation Department, East China University of Science hybrid intelligence algorithm (HIA) based on the previous
and Technology, Shanghai 200237, China (e-mail: fqian@ecust.edu.cn). two sections. Section VII reports the corresponding computa-
Color versions of one or more of the figures in this paper are available online
at http://ieeexplore.ieee.org. tional and comparative results. Finally, conclusions are made in
Digital Object Identifier 10.1109/TSMCA.2007.914753 Section VIII.

1083-4427/$25.00 © 2008 IEEE


GE et al.: EFFECTIVE PSO AND AIS-BASED HYBRID INTELLIGENT ALGORITHM 359

II. JSSP
The job-shop problem studied in the paper consists of
scheduling a set of jobs on a set of machines with the objective
of minimizing the makespan, i.e., the maximum of completion
times needed for processing all jobs. Each machine can handle
at most one job at a time. Each job consists of a chain of
operations that is to be processed in a specified sequence, on
specified machines, and during an uninterrupted time period of
given length. Fig. 1. Relationship of schedule properties.
Explaining the problem more specifically, let J = {1, 2,
. . . , n} denote the set of jobs, M = {1, 2, . . . , m} represent the which operations are placed into the schedule such that the
set of machines, and O = {0, 1, . . . , n × m, n × m + 1} be the machine idle time is minimized and that no machine is kept
set of operations that is to be scheduled, where 0 and n × m + 1 idle if some operations can be processed. Their relationships
represent the dummy initial and final operations, respectively. [31] are shown in Fig. 1. The optimal schedule is guaranteed
The operations are interrelated by the precedence constraints, to be an active schedule. Therefore, we only need to find the
which force each operation j to be scheduled after all pre- optimum solution in the set of active schedules.
decessor operations Pj are completed. Moreover, operation j
can only be scheduled if the machine that it requires is idle. III. R EPRESENTATION AND I NITIAL
Furthermore, let Tj and Fj denote the fixed processing time S CHEDULE G ENERATION
and the finish time of operation j, respectively, let A(t) be the
set of operations being processed at time t, and let ejm = 1 A. Representation
if operation j is required to process on machine m (ejm = 0 Before solving the JSSP, we describe the proper represen-
otherwise). tation for the solution of the problem, namely, a scheduling,
The conceptual model of the JSSP can be stated as [30] which is used in the later algorithms. In this paper, an operation-
based representation is adopted, which uses an unpartitioned
min Fn×m+1 (1)
permutation with m-repetitions of job numbers for problems
s.t. Fk ≤ Fj − Tj , j = 1, 2, . . . , n × m + 1; k ∈ Pj with n jobs and m machines. A job represents a set of opera-
(2) tions that has to be scheduled on m machines. In this formula-
 tion, each job number occurs m times in the permutation. By
ejm ≤ 1, m ∈ M; t≥0 (3) scanning the permutation from left to right, the kth occurrence
j∈A(t) of a job number refers to the kth operation in the technological
Fj ≥ 0, j = 1, 2, . . . , n × m + 1. (4) sequence of this job. A permutation with repetition of job
numbers only expresses the order in which the operations of
The objective function (1) minimizes the finish time of the jobs are scheduled.
last operation, namely, the makespan. Constraint (2) imposes For example, suppose that a sequence is given as (2 1 3 4 2 4
the precedence relations between operations. Constraint (3) 3 2 1 2 3 3 1 1 4 4) in a 4 jobs × 4 machines problem, in which
represents that one machine can only process one operation each gene stands for one operation. Each job consists of four
at a time, and constraint (4) forces the finish times to be operations, and the job number is thereby repeated four times.
nonnegative. The fifth gene of the permutation implies the second operation
The solution of the JSSP can be represented as the operation of job 2 because number 2 has been repeated twice. Similarly,
permutation of jobs on each machine. The total number of the eighth gene represents the third operation of job 2, and so
all possible schedules (both feasible and infeasible) is (n!)m on. The prominent advantage is that the permutation is always
for problems with n jobs and m machines. Obviously, it is feasible. Moreover, it eliminates the deadlock schedules that are
impossible to exhaust all the alternatives for finding the optimal incompatible with the technological constraints and can never
solution even if the values of n and m are small. For example, be finished. However, it will produce redundancy in the search
for the Fisher–Thompson benchmark problem of ten jobs to ten space and will cause the search-space size to expand to (n ×
machines, it has a search space with a size at about 3.96 × 1065 . m)!/(m!)n , i.e., the mapping relation between sequences and
Thus, it is necessary to restrict the search space and to guide schedules is many-to-one.
the search process. There are four types of feasible schedules in
JSSP, namely, inadmissible, semiactive, active, and nondelay.
B. Initial Schedule Generation
Inadmissible schedules contain excess idle time, and they can
be improved by forward-shifting operations until no excess idle A good initial solution is fundamental for the computational
time exists. Semiactive schedules contain no excess idle time, performance of a search algorithm. If the initial population is
but they can be improved by shifting some operations to the generated randomly, the generation of the optimal schedule not
front without delaying others. Active schedules contain no idle only requires longer time but also decreases the possibility to
time, and no operation can be finished earlier without delaying obtain an optimal solution. In this paper, a new scheduling
other operations. Nondelay schedules are active schedules, in initialization algorithm is proposed based on the well-known
360 IEEE TRANSACTIONS ON SYSTEMS, MAN, AND CYBERNETICS—PART A: SYSTEMS AND HUMANS, VOL. 38, NO. 2, MARCH 2008

algorithm of Giffler and Thompson [32] to produce active Let the ith particle in a D-dimensional space be repre-
schedules. The brief outline of the algorithm is as follows. sented as Xi = (xi1 , . . . , xid , . . . , xiD ). The best previous po-
Step 1) Let set A contain the first schedulable operation of sition of the ith particle is recorded and represented as Pi =
each job. Let sjm = 0, for all operations (j, m) in (pi1 , . . . , pid , . . . , piD ), which gives the best fitness value and
A, where sjm is the earliest time at which operations is also called “pbest.” The index of the best pbest among
(j, m) can start. all particles is represented by symbol g. Location Pg is also
Step 2) Calculate t(A) = min(sjm + pjm ), for all opera- called “gbest.” The velocity for the ith particle is represented
tions (j, m) ∈ A, where pjm is the processing time as Vi = (νi1 , . . . , νid , . . . , νiD ). The concept of PSO consists
of operations (j, m). of changing the velocity and location of each particle toward its
Step 3) Set up set M , for all operations (j, m) ∈ A, if sjm < pbest and gbest locations according to the following equations
t(A), and then put machine m into set M . at each time step:
Step 4) Set up set G, randomly select a machine m∗ from
M for all operations (j, m) ∈ A, and put operation νid = wνid + c1 r1 (pid − xid ) + c2 r2 (pgd − xid ) (5)
(j, m) into set G if it is processed on machine m∗ . xid = xid + νid (6)
Step 5) For all operations (j, m∗ ) ∈ G, calculate the earliest
completed time of job j if operation (j, m∗ ) is where w is the inertia coefficient that is a constant in the interval
currently processed. Let j ∗ denote the job that is [0, 1], c1 and c2 are the learning rates that are nonnegative
completed last. constants, r1 and r2 are generated randomly in the interval
Step 6) Select operation (j ∗ , m∗ ) from G, and append it to [0, 1], νid ∈ [−νmax , νmax ], and νmax is the designated max-
the schedule. imum velocity.
Step 7) Delete operation (j ∗ , m∗ ) from A, and then subjoin The conventional PSO cannot be directly applied to the JSSP.
its immediate successor into A. In this section, we describe the formulations of the proposed
Step 8) Update sjm in A, and then return to Step 2) until A PSO algorithm for the JSSP. First, the concept of the difference
is empty, namely, all operations are scheduled. of the locations is extended. Let us present the similarity
According to the algorithm proposed by Giffler and measure of two particles. Denote the ith and jth particles in
Thompson, the operation with an early start time and a mini- a D-dimensional space as Xi = (xi1 , . . . , xid , . . . , xiD ) and
mum processing time possesses a high priority to be scheduled. Xj = (xj1 , . . . , xjd , . . . , xjD ), respectively. Define functions
In our algorithm, besides the aforementioned rule, we also 
consider the degree of the effect on the makespan when a 1, if xik = xjk 
D
s(k) = and S(Xi , Xj ) = s(k) (7)
schedulable operation is delayed in the current schedule set. 0, if xik = xjk
k=1
Therefore, we first need to calculate the earliest finishing time
of each job in the current schedule set and find the job with where S(Xi , Xj ) is called the similarity measure between
the longest finishing time. The effect on the makespan is great particles Xi and Xj . Let f (Xi ) denote the fitness of particle
when its corresponding current operation is delayed. Thus, the i and assume that 0 ≤ f (Xi ) ≤ C, ∀i ∈ {1, 2, . . . , n}, where n
corresponding current operation of the job has a high priority to is the population size. The difference of the locations between
be scheduled just as Step 5) stated. two particles (namely, “distance”) is redefined by the following
equation:
IV. PSO-B ASED S CHEDULING A LGORITHM
dis(Xi − Xj ) = k · [α · |f (Xi ) − f (Xj )| /C
PSO, originally developed by Kennedy and Eberhart [33],
is a method for optimizing hard numerical functions on the + β · (D − S(Xi , Xj )) /D] (8)
metaphor of social behaviors of flocks of birds and schools
where D is the dimension of a particle; k is a positive integer
of fish. It is an evolutionary computation technique based on
that is called the acceleration coefficient; and α and β are two
swarm intelligence. A swarm consists of individuals, called
positive weights, which can be ascertained by trial and error and
particles, which change their positions over time. Each particle
satisfy the relation that the sum of α and β is equal to one. In
represents a potential solution to the problem. In a PSO sys-
this paper, α and β are taken as 0.7 and 0.3, respectively. It is
tem, particles fly around in a multidimensional search space.
obvious that 0 ≤ |f (Xi ) − f (Xj )|/C ≤ 1 and that 0 ≤ (D −
During its flight, each particle adjusts its position according
S(Xi , Xj ))/D ≤ 1.
to its own experience and the experience of its neighboring
Correspondingly, the concept of velocity is also extended.
particles, making use of the best position encountered by itself
Velocity is defined as the time of “adjustment operation.” The
and its neighbors. The effect is that particles move toward the
brief outline of the adjustment algorithm is as follows.
better solution areas while still having the ability to search a
Let X = (x1 , . . . , xk , . . . , xD ) and Y = (y1 , . . . , yk ,
wide area around the better solution areas. The performance
. . . , yD ) be the two particles in a D-dimensional space.
of each particle is measured according to a predefined fitness
function, which is related to the problem being solved. PSO Step 1) Randomly select an index k of location, and set
has been found to be robust and fast in solving nonlinear, indicator m = 0 if xk = yk = s, where s is the
nondifferentiable, and multimodal problems. The mathematical number on location k. Go to Step 2); else, if xk =
description and executive steps of the PSO are as follows. yk , namely, xk = s and yk = s, go to Step 3).
GE et al.: EFFECTIVE PSO AND AIS-BASED HYBRID INTELLIGENT ALGORITHM 361

Step 2) Scan sets X  = {xi |1 ≤ i < k} and Y  = {yi |1 ≤


i < k} from left to right to find out the times that
s appears, and denote them as X  _times(s) = tx
and Y  _times(s) = ty , respectively. If tx > ty , go
to Step 4); if tx < ty , go to Step 5); in addition, if
tx = ty , go to Step 6).
Step 3) Randomly select a location index j in the particle Y ,
which satisfies yj = s and yj = xj . Swap yj and yk ,
set indicator m = 1, and then go to Step 2).
Step 4) Swap s, which appears after location k, and yj ,
Fig. 2. Example of vaccination.
which satisfies that yj = xj , yj = s, and j < k until
tx = ty , and then go to Step 7).
Step 5) Swap s, which appears in front of location k, and yj , B. Vaccination and Mutation
which satisfies that yj = xj , yj = s, and j > k until
tx = ty , and then go to Step 7). In this section, a novel vaccination operation is proposed.
Step 6) If m = 0, randomly reselect an index k, whereas if Vaccination shows how strongly we benefit from the ability
m = 1, go to Step 7). of our immune system to show an improved reaction after
Step 7) Terminate. a previous contact with the same or a very similar pathogen
(or infectious agent) or parts of it. It is constantly helping us
Using “⊕” to denote the adjustment operation, the proposed in our defense against the omnipresent enemies attacking our
PSO algorithm could be performed by the following equations: health. The regulatory mechanisms of the immune system make
modulation of the immune response to antigens toward those
νid = int [wνid +c1 r1 dis(pid −xid )+c2 r2 dis(pgd −xid )] (9)
responses that are protective against the pathogen, whether
xid = xid ⊕ νid (10) antibody-based or cell-mediated. We take full advantage of
some characteristic information and knowledge in the process
where int[·] represents the truncation function, and dis(·) can of solving problem to distill vaccines and then vaccinate some
be calculated using (8). antibodies, similarly to the techniques of vaccine inoculation.
In this paper, the parameters are taken as w = 0.5, c1 = 1.8, The process of vaccination is designed as follows. First, the
and c2 = 1.0. antibody with the highest affinity is recognized, which is called
here the best antibody, and then an antibody is selected for
V. AIS-B ASED S CHEDULING A LGORITHM vaccination. Produce a vector of length j × m for the problem
of j jobs and m machines, which is randomly filled with
AIS is rapidly emerging, which is inspired by theoretical
elements of set {0, 1}. This vector defines the order in which the
immunology and observed immune functions, principles, and
genes of the newly produced antibody molecule are drawn from
models. An immune system is a naturally occurring event-
the best and selected antibodies. After a gene is drawn from one
response system that can quickly adapt to changing situations.
antibody and deleted from the other one, it is appended to the
The efficient mechanisms of an immune system, including
newly produced antibody molecule. This step is repeated until
clonal selection, learning ability, memory, robustness and flexi-
both the best and selected antibody molecules are empty and the
bility, make AISs useful in many application fields. AIS appears
produced antibody contains all the genes involved. An offspring
to offer powerful and robust information processing capabilities
is created by using an operator and is accepted into the next
for solving complex problems. In this section, a new AIS-based
population if the affinity value is higher than the original. Fig. 2
scheduling algorithm is proposed. The proposed algorithm is
shows an example of the vaccination.
built on the principles of clonal selection, affinity maturation,
In immune systems, random changes take place in the
and the abilities of learning and memory.
variable-region genes of antibody molecules. These random
changes are called mutations. Mutations cause structurally
A. Clonal Selection different antibody molecules. In AIS for solving the JSSP,
Clonal-selection probability is a direct proportion to anti- the number of mutational genes in an antibody molecule is
body affinity: The higher the affinity an antibody has with an inversely proportional to the antibody affinity. The higher the
antigen, the higher the selection chance and the clonal rate. affinity an antibody has with an antigen, the smaller the mu-
Therefore, the proportional model is adopted in this paper. It is tation bits. The number of mutational genes in an antibody
a direct-ratio selection strategy and can be used to select a new molecule is decided by the following formula:
population according to the direct ratio with respect to fitness  
values. First, calculate the sum fsum of affinity values of all the (fmax − f )(ρ − η)
bit = int +η (11)
antibodies in the population, and then generate a pseudorandom fmax − fmin
number m in the interval [0, fsum ] by the multiplicative congru-
ential method. Last, sum up the affinity values one by one from where bit is the number of mutational genes, int[·] is the
the first antibody until the accumulated value is not smaller than truncation function, f is the affinity of mutational antibody,
m, and the last accumulated antibody is the cloned one. fmax and fmin are the maximal and minimal affinities in the
362 IEEE TRANSACTIONS ON SYSTEMS, MAN, AND CYBERNETICS—PART A: SYSTEMS AND HUMANS, VOL. 38, NO. 2, MARCH 2008

population, respectively, and ρ and η are the upper and lower TABLE I
EXAMPLE FOR 3 JOBS × 2 MACHINES
bounds of mutation bits, respectively, which are adjustable
integers. Mutation operations are completed by selecting bit
positions from the antibody molecule and randomly permuting
the genes on these positions. The mutated antibody replaces its
original regardless of its fitness value.

C. Receptor Editing
Due to the random nature of mutation processes, a large
proportion of mutating genes become nonfunctional or develop
into harmful antiself specificities. Those cells are eliminated
by a programmed death process that is known as receptor
editing. The proposed receptor-editing model embodies the two Fig. 3. Gantt chart of semiactive scheduling.
operations of antibody introduction and gene shift.
If there is no improvement of the highest affinity degree for
a certain number of generations, the two operations are per-
formed. The antibody introduction is that a certain percentage
of antibodies are randomly produced by the proposed initializa-
tion algorithm in Section III and replace the worst antibodies of
the whole population. The process of gene shift is described as
follows. Randomly select some antibodies. For every selected Fig. 4. Gantt chart of active scheduling.
antibody, randomly select a gene of the antibody molecule.
Make it move backward in turn, and once shift one position
until it moves λ times and then λ new antibodies are produced.
We replace the original antibody by the produced antibody with
the highest affinity if it is better than the original one.

D. AIS-Based Scheduling Algorithm


The brief outline of the proposed algorithm based on AIS can
be described as follows.
Step 1) Initialize pop_size antibodies as an initial popula-
tion by using the proposed initialization algorithm,
where pop_size denotes the population size.
Step 2) Select m antibodies from the population by the
proportional selection model and clone them to a
clonal library.
Step 3) Perform the mutation operation for each of the anti-
bodies in the clonal library.
Step 4) Randomly select s antibodies from the clonal library Fig. 5. Flowchart of the hybrid algorithm for the JSSP.
to perform the operation of vaccination.
Step 5) Replace the worst s antibodies in the population by scheduling such that
the best s antibodies from the clonal library.
Step 6) Perform the operation of receptor editing if there is min (T (JM )) = min {max [T (1), T (2),. . ., T (i),. . ., T (m)]}
no improvement of the highest affinity degree for a (12)
certain number of generations G. where T (i) is the final completion time of machining on the ith
Step 7) Stop if the termination condition is satisfied; else, machine, and T (JM ) is the final completion time of all jobs.
repeat Steps 2)–7). Fitness and affinity are evaluated by using the following
In this paper, the parameters are taken as pop_size = 50, equation:
m = 30, s = 10, and G = 80.
fi = 100 × opt/Ti (JM ) (13)

where fi , which is in interval (0, 100], is the fitness value of


VI. HIA B ASED ON THE P ROPOSED PSO AND AIS
ith particle in PSO and is also the affinity value of ith antibody
Based on the models of the proposed PSO and AIS, the HIA in AIS, and opt is the theoretical optimal makespan for a given
is integrated to solve the JSSP. The objective is to search a problem.
GE et al.: EFFECTIVE PSO AND AIS-BASED HYBRID INTELLIGENT ALGORITHM 363

TABLE II
COMPARISONS OF RESULTS BETWEEN THE HIA AND OTHER APPROACHES

The value of the objective function T (JM ) can be obtained solution is the sequence a = (1, 3, 2, 2, 1, 3). Its Gantt chart
by the process of decoding. The makespan is produced by the by the semiactive decoding scheme is shown in Fig. 3, whose
process that assigns operations to the machines at their earliest makespan is seven units. On the other hand, the makespan by
possible starting time by the technological order of each job, the active decoding is six units, and the corresponding Gantt
scanning the permutation from left to right. It should be noticed chart is shown in Fig. 4.
that the scheduling that is acquired this way is only a semiactive It is worth mentioning that fitness and affinity are as pivotal
one. Yet, the optimal solution must be an active schedule. Then, to the guidance of the search and clonal selection because the
the active decoding is applied, which checks the possible blank chance of a solution being chosen is determined solely by its ob-
time interval before appending an operation at the last position jective function value. Thus, their values are linearly adjusted to
and fills the first blank interval before the last operation to avoid early convergence and to ensure the variety of the popula-
convert the semiactive schedule to an active one so that the tion. The adjustment process can be summarized as follows.
makespan can be shorter. For example, consider the 3 jobs ×
2 machines problem shown in Table I. In the example, job 1 Step 1) Calculate the average fitness and affinity fave ,
must go to machine 2 for one unit of time, then to machine 1 for the maximal fmax and the minimal fmin in the
two units of time, and so on. Suppose that an operation-based population.
364 IEEE TRANSACTIONS ON SYSTEMS, MAN, AND CYBERNETICS—PART A: SYSTEMS AND HUMANS, VOL. 38, NO. 2, MARCH 2008

TABLE II
(Continued.) COMPARISONS OF RESULTS BETWEEN THE HIA AND OTHER APPROACHES

Step 2) If fmin > 2fave − fmax , go to Step 3); else, go to


Step 4).
TABLE III Step 3) Calculate coefficients α = (fave /fmax − fave ) and
AVERAGE EXPERIMENTAL RESULTS USING THE HIA
β = ((fmax − 2fave )fave /fmax − fave ). Go to
Step 5).
Step 4) Calculate coefficients α = (fave /fave − fmin ) and
β = (−fmin fave /fave − fmin ). Go to Step 5).
Step 5) Calculate the new fitness value by using the equation
f  = αf + β.

The flowchart of the hybrid algorithm is shown in Fig. 5.


Furthermore, the proposed algorithm stops if the best obtained
solution equals to the best known makespan or if, for a given
number cnt of generations, there has been no improvement
of the best solution found so far, where cnt = 20 000. The
GE et al.: EFFECTIVE PSO AND AIS-BASED HYBRID INTELLIGENT ALGORITHM 365

Fig. 6. Representative convergence curve for FT10.


Fig. 7. Convergence curves for different values of the parameter δ.
advantage of the proposed hybrid algorithm is that it can
produce quite satisfactory solutions of the test problems in a found makespan from the best known solution is only on
reasonable time. On the one hand, the proposed PSO model average 0.28%. The proposed algorithm yields a significant
has the ability to approximate the quasi-optimum solution very improvement in solution quality with respect to almost all
fast; on the other hand, the proposed AIS model has the ability other algorithms, except for the approach proposed by Nowicki
to escape from local minimum. and Smutnicki that has a better performance in the 15 × 15
problems mainly. The superior results indicate the successful
incorporation of the improved PSO and AIS, which facilitates
VII. N UMERICAL S IMULATION
the escape from local minimum points and increases the possi-
R ESULTS AND C OMPARISONS
bility of finding a better solution. Therefore, it can be concluded
The performance of the proposed HIA for the JSSP is that the proposed HIA solves the JSSP fairly efficiently.
examined by using some test problems taken from the OR- As aforementioned, the algorithm is performed five times
Library [34]. We consider 43 instances from two classes of for every test problem by taking the parameter δ as zero, one,
standard JSSP test problems: instances FT06, FT10, and FT20 and two. Table III lists the mean solutions (Mean), the relative
that are designed by Fisher and Thompson (1963) and instances deviation of the mean solution (MRD), the standard deviation
LA01–LA40 that are designed by Lawrence (1984). Numerical of the solutions (SD), the best solution (Best), and the relative
experiments are performed in C++ language on a PC with deviation of the best solution (BRD). The MRD is commonly
Pentium IV 1.4-GHz processor and 256-MB memory. Numer- zero for small-size problem and is not more than 2% for most
ical results are compared with those reported in some existing other problems.
literature works using other approaches [29], [30], [35]–[44], To illustrate the simulated results more intuitively, the no-
including some heuristic and metaheuristic algorithms. torious FT10 problem is specifically described as an example,
Table II summarizes the results of the experiments. The in which there are numerous local optima so that the problem
contents of the table include the name of each test problem is challenging enough. Fig. 6 shows the representative conver-
(Instance), the scale of the problem (Size), the value of the gence curve finding the best solution. To investigate the effect
best known solution for each problem (BKS), the value of the of δ-tuning on the solution quality and convergence, Fig. 7
best solution found by using the proposed algorithm (HIA), shows a group of convergence curves for different values of the
the number of running generations (Iterations), the percentage parameter δ. Fig. 8 shows the Gantt chart of the best solution.
of the deviation with respect to the best known solution (RD%), Define the utilization percentage of the ith machine as
and the best results reported in other research works. It is worth
mentioning that the makespan listed in the table is the best Pi
Ui = × 100% (15)
obtained from five executions by inching the defined fitness Ii + Pi
function (13), which is changed according to the following
equation: where Pi is the total processing time of machine i, and Ii is
the total idle time of machine i before the last operation in the
fi = 100 × (opt ± δ)/Ti (JM ) (14) machine is processed. Fig. 9 shows the percentage of utilization
of each machine.
where δ is the tuning parameter, and its values are taken as Let Di denote the blank interval between makespan and the
zero, one, and two. The proposed algorithm produces quite finish time of the last operation completed in the machine i,
satisfactory solutions in reasonable amount of iterations by which is called here the dormancy time of machine i. Then
tuning only the parameter δ.
From the table, it can be seen that the proposed algorithm Di + Ii + Pi = makespan ∀i ∈ {1, 2, . . . , M } (16)
is able to find the best known solution for 32 instances, i.e., in
about 75% of the instances, and the deviation of the minimum where M is the number of machines.
366 IEEE TRANSACTIONS ON SYSTEMS, MAN, AND CYBERNETICS—PART A: SYSTEMS AND HUMANS, VOL. 38, NO. 2, MARCH 2008

Fig. 8. Gantt chart of an optimal schedule for FT10.

Fig. 9. Column chart of percentage of utilization. Fig. 10. Pie chart of percentage of different times.

The percentages of the total processing, idle, and dormancy


times for all the machines are calculated, respectively, by G&T algorithm is proposed to produce the initial population
 in the PSO and AIS. The proposed hybrid algorithm effectively
Pi exploits the capabilities of distributed and parallel computing
P% =  i
× 100% (17) of swarm intelligence approaches. The algorithm is tested on
(Di + Ii + Pi ) a set of 43 standard instances taken from the OR-Library.
i
 Computational results are compared with those obtained using
Ii other existing approaches, and the proposed approach yields
I% =  i
× 100% (18) significant improvement in solution quality. The superior re-
(Di + Ii + Pi )
i sults indicate the successful incorporation of the two improved
 swarm intelligence approaches. The investigation on further
Di
study for the theoretical research, as well as the performance
D% =  i
× 100%. (19) of the technique, is in progress. One of the important issues
(Di + Ii + Pi )
i is to extend the proposed algorithm so that it can be applied
to more practical and integrated manufacturing problems such
The aforementioned percentages are shown in Fig. 10.
as dynamic arrivals, machine breakdown, or other factors that
affect job status over time.
VIII. C ONCLUSION
A promising HIA that combines the improved PSO and AIS R EFERENCES
is proposed to solve job-shop problems with minimization of
[1] R. Heilmann, “A branch-and-bound procedure for the multi-mode
the makespan. In the particle swarm system, a novel concept resource-constrained project scheduling problem with minimum and max-
for the distance and velocity of a particle is presented for imum time lags,” Eur. J. Oper. Res., vol. 144, no. 2, pp. 348–365,
the JSSP. In the AIS, the models of vaccination and receptor Jan. 2003.
[2] C. Akkan and S. Karabati, “The two-machine flowshop total completion
editing are designed to improve the immune performance. In time problem: Improved lower bounds and a branch-and-bound algo-
addition, a new scheduling initialization algorithm based on rithm,” Eur. J. Oper. Res., vol. 159, no. 2, pp. 420–429, Dec. 2004.
GE et al.: EFFECTIVE PSO AND AIS-BASED HYBRID INTELLIGENT ALGORITHM 367

[3] T. Lorigeon, “A dynamic programming algorithm for scheduling jobs in [28] S. Yang and D. Wang, “Constraint satisfaction adaptive neural network
a two-machine open shop with an availability constraint,” J. Oper. Res. and heuristics combined approaches for generalized job-shop schedul-
Soc., vol. 53, no. 11, pp. 1239–1246, Nov. 2002. ing,” IEEE Trans. Neural Netw., vol. 11, no. 2, pp. 474–486, Mar. 2000.
[4] C. N. Potts and L. N. Van Wassonhove, “Dynamic programming and de- [29] C. A. C. Coello, D. C. Rivera, and N. C. Cortes, “Use of an artificial
composition approaches for the single machine total tardiness problem,” immune system for job shop scheduling,” in Proc. 2nd Int. Conf. Artif.
Eur. J. Oper. Res., vol. 32, no. 3, pp. 405–414, Dec. 1987. Immune Syst., 2003, vol. 2787, pp. 1–10.
[5] Y. B. Canbolat and E. Gundogar, “Fuzzy priority rule for job shop schedul- [30] J. F. Goncalves, J. J. D. M. Mendes, and M. G. C. Resende, “A hybrid
ing,” J. Intell. Manuf., vol. 15, no. 4, pp. 527–533, Aug. 2004. genetic algorithm for the job shop scheduling problem,” Eur. J. Oper. Res.,
[6] R. Klein, “Bidirectional planning: Improving priority rule-based heuris- vol. 167, no. 1, pp. 77–95, Nov. 2005.
tics for scheduling resource-constrained projects,” Eur. J. Oper. Res., [31] C. Bierwirth and D. C. Mattfeld, “Production scheduling and rescheduling
vol. 127, no. 3, pp. 619–638, Dec. 2000. with genetic algorithms,” Evol. Comput., vol. 7, no. 1, pp. 1–17, Jan. 1999.
[7] J. B. Jensen, P. R. Philipoom, and M. K. Malhotra, “Evaluation of schedul- [32] J. Giffler and G. L. Thompson, “Algorithms for solving production
ing rules with commensurate customer priorities in job shops,” J. Oper. scheduling problems,” Oper. Res., vol. 8, no. 4, pp. 487–503, Aug. 1960.
Manage., vol. 13, no. 3, pp. 213–228, Oct. 1995. [33] J. Kennedy and R. Eberhart, “Particle swarm optimization,” in Proc. IEEE
[8] W. Q. Huang and A. H. Yin, “An improved shifting bottleneck procedure Int. Conf. Neural Netw., Perth, Australia, 1995, vol. 4, pp. 1942–1948.
for the job shop scheduling problem,” Comput. Oper. Res., vol. 31, no. 12, [34] J. E. Beasley, “OR-Library: Distributing test problems by electronic
pp. 2093–2110, Oct. 2004. mail,” J. Oper. Res. Soc., vol. 41, no. 11, pp. 1069–1072, 1990.
[9] F. Pezzella and E. Merelli, “A tabu search method guided by shifting bot- [35] B. M. Ombuki and M. Ventresca, “Local search genetic algorithms for the
tleneck for the job shop scheduling problem,” Eur. J. Oper. Res., vol. 120, job shop scheduling problem,” Appl. Intell., vol. 21, no. 1, pp. 99–109,
no. 2, pp. 297–310, Jan. 2000. Jul./Aug. 2004.
[10] H. X. Chen and P. B. Luh, “An alternative framework to Lagrangian [36] R. M. Aiex, S. Binato, and M. G. C. Resende, “Parallel GRASP with
relaxation approach for job shop scheduling,” Eur. J. Oper. Res., vol. 149, path-relinking for job shop scheduling,” Parallel Comput., vol. 29, no. 4,
no. 3, pp. 499–512, Sep. 2003. pp. 393–430, Apr. 2003.
[11] C. A. Kaskavelis and M. C. Caramanis, “Efficient Lagrangian relaxation [37] L. Wang and D. Z. Zheng, “A modified genetic algorithm for job shop
algorithms for industry size job-shop scheduling problems,” IIE Trans., scheduling,” Int. J. Adv. Manuf. Technol., vol. 20, no. 1, pp. 72–76,
vol. 30, no. 11, pp. 1085–1097, Nov. 1998. Jan. 2002.
[12] F. Geyik and I. H. Cedimoglu, “The strategies and parameters of tabu [38] S. Binato, W. J. Hery, D. M. Loewenstern, and M. G. C. Resende, “A
search for job-shop scheduling,” J. Intell. Manuf., vol. 15, no. 4, pp. 439– GRASP for job shop scheduling,” in Essays and Surveys in Metaheuris-
448, Aug. 2004. tics. Boston, MA: Kluwer, 2001, pp. 59–80.
[13] J. P. Watson, J. C. Beck, and A. E. Howe, “Problem difficulty for tabu [39] I. Sabuncuoglu and M. Bayiz, “Job shop scheduling with beam search,”
search in job-shop scheduling,” Artif. Intell., vol. 143, no. 2, pp. 189–217, Eur. J. Oper. Res., vol. 118, no. 2, pp. 390–412, Oct. 1999.
Feb. 2003. [40] P. S. Dauzere and J. Paulli, “An integrated approach for modeling and
[14] S. G. Ponnambalam, P. Aravindan, and S. V. Rajesh, “A tabu search solving the general multiprocessor job-shop scheduling problem using
algorithm for job shop scheduling,” Int. J. Adv. Manuf. Technol., vol. 16, tabu search,” Ann. Oper. Res., vol. 70, no. 1, pp. 281–306, 1997.
no. 10, pp. 765–771, Oct. 2000. [41] W. P. W. Nuijten and E. H. L. Aarts, “Computational study of constraint
[15] T. K. Liu, J. T. Tsai, and J. H. Chou, “Improved genetic algorithm for satisfaction for multiple capacitated job shop scheduling,” Eur. J. Oper.
the job-shop scheduling problem,” Int. J. Adv. Manuf. Technol., vol. 27, Res., vol. 90, no. 2, pp. 269–284, Apr. 1996.
no. 9/10, pp. 1021–1029, Feb. 2006. [42] E. Nowicki and C. Smutnicki, “A fast taboo search algorithm for the job
[16] S. Hajri, N. Liouane, S. Hammadi, and P. Borne, “A controlled genetic shop problem,” Manage. Sci., vol. 42, no. 6, pp. 797–813, 1996.
algorithm by fuzzy logic and belief functions for job-shop scheduling,” [43] F. D. Croce, R. Tadei, and G. Volta, “A genetic algorithm for the job shop
IEEE Trans. Syst., Man, Cybern. B, Cybern., vol. 30, no. 5, pp. 812–818, problem,” Comput. Oper. Res., vol. 22, no. 1, pp. 15–24, Jan. 1995.
Oct. 2000. [44] U. Dorndorf and E. Pesch, “Evolution based learning in a job shop
[17] X. Gang and Z. M. Wu, “Deadlock-free scheduling strategy for automated scheduling environment,” Comput. Oper. Res., vol. 22, no. 1, pp. 25–40,
production cell,” IEEE Trans. Syst., Man, Cybern. A, Syst., Humans, Jan. 1995.
vol. 34, no. 1, pp. 113–122, Jan. 2004.
[18] K. S. Amirthagadeswaran and V. P. Arunachalam, “Improved solutions for
job shop scheduling problems through genetic algorithm with a different
method of schedule deduction,” Int. J. Adv. Manuf. Technol., vol. 28,
no. 5/6, pp. 532–540, Mar. 2006.
[19] C. Low, J. Y. Yeh, and K. I. Huang, “A robust simulated annealing Hong-Wei Ge received the B.S. and M.S. degrees in
heuristic for flow shop scheduling problems,” Int. J. Adv. Manuf. Technol., mathematics and the Ph.D. degree in computer appli-
vol. 23, no. 9/10, pp. 762–767, May 2004. cation technology from Jilin University, Changchun,
[20] T. Y. Wang and K. B. Wu, “A revised simulated annealing algorithm for China, in 2000, 2003, and 2006, respectively.
obtaining the minimum total tardiness in job shop scheduling problems,” He is currently a Postdoctor with the School of
Int. J. Syst. Sci., vol. 31, no. 4, pp. 537–542, Apr. 2000. Information Science and Engineering, East China
[21] M. Kolonko, “Some new results on simulated annealing applied to the job University of Science and Technology, Shanghai,
shop scheduling problem,” Eur. J. Oper. Res., vol. 113, no. 1, pp. 123–136, China. His current research interests include com-
Feb. 1999. putational intelligence, optimization and modeling,
[22] R. K. Suresh and K. M. Mohanasundaram, “Pareto archived simulated system control, and bioinformatics. He has published
annealing for job shop scheduling with multiple objectives,” Int. J. Adv. more than 30 papers in these areas. His research was
Manuf. Technol., vol. 29, no. 1/2, pp. 184–196, Jan. 2006. featured in Computers and Structures, the Journal Nonlinear Analysis: Real
[23] J. Zhang, X. M. Hu, X. Tan, J. H. Zhong, and Q. Huang, “Implemen- World Applications, and Lecture Notes in Computer Science.
tation of an ant colony optimization technique for job shop schedul-
ing problem,” Trans. Inst. Meas. Control, vol. 28, no. 1, pp. 93–108,
Jan. 2006.
[24] Z. G. Lian, B. Jiao, and X. S. Gu, “A similar particle swarm optimization
algorithm for job-shop scheduling to minimize makespan,” Appl. Math.
Comput., vol. 183, no. 2, pp. 1008–1017, Dec. 2006. Liang Sun received the B.S. degree in computer sci-
[25] W. J. Xia and Z. M. Wu, “A hybrid particle swarm optimization approach ence and technology from Xidian University, Xi’an,
for the job-shop scheduling problem,” Int. J. Adv. Manuf. Technol., vol. 29, China, and the M.S. degree in computer application
no. 3/4, pp. 360–366, Jun. 2006. technology from Jilin University, Changchun, China,
[26] H. B. Yu and W. Liang, “Neural network and genetic algorithm-based in 2003 and 2006, respectively, where he is currently
hybrid approach to expanded job-shop scheduling,” Comput. Ind. Eng., working toward the Ph.D. degree in the College of
vol. 39, no. 3/4, pp. 337–356, Apr. 2001. Computer Science and Technology.
[27] S. Yang and D. Wang, “A new adaptive neural network and heuristics His current research interests include computa-
hybrid approach for job-shop scheduling,” Comput. Oper. Res., vol. 28, tional intelligence and bioinformatics.
no. 10, pp. 955–971, Sep. 2001.
368 IEEE TRANSACTIONS ON SYSTEMS, MAN, AND CYBERNETICS—PART A: SYSTEMS AND HUMANS, VOL. 38, NO. 2, MARCH 2008

Yan-Chun Liang received the Ph.D. degree in me- Feng Qian received the Ph.D. degree in automation
chanics from Jilin University, Changchun, China, from East China University of Science and Technol-
in 1993. ogy, Shanghai, in 1995.
He is currently a Professor with the College of He is currently a Professor with the Automation
Computer Science and Technology, Jilin University Department, East China University of Science and
and a Visiting Professor with the Institute of High Technology. His current research interests include
Performance Computing, Singapore. He is a recip- control theory and application, industry instrument
ient of several grants, such as the National Science automation, and chemistry engineering. He has pub-
Foundation of China, etc. His research interests in- lished more than 100 papers in these areas.
clude the theory and applications of computational
intelligence, bioinformatics, etc. He has published
over 160 papers. His research was featured in the Journal of Micromechan-
ics and Microengineering, the Physical Review E, the Neural Computing &
Applications, and the Journal Applied Artificial Intelligence.
Dr. Liang is the Chair of many conferences and is on the editorial board of
several journals.

Potrebbero piacerti anche