matlab遗传算法选址
❶ 谁有基于遗传算法的物流中心选址matlab程序,能发我一下吗
您好,遗传算法matlab本身就带的,为何不用软件本身的?
自己写的有时候没有自带的标准,不好说是算法本身的问题还是模型的问题。
❷ 急求车辆路径问题遗传算法的matlab代码!!!!
function[path,lmin]=ga(data,d)%data为点集,d为距离矩阵,即赋权图
tic
%======================
sj0=data;%开环最短路线
%=================================
%sj0=[data;data(1,:)];%闭环最短路线
%=========================
x=sj0(:,1);y=sj0(:,2);
N=length(x);
%=========================
%d(N,:)=d(1,:);%闭环最短路线
%d(:,N)=d(:,1);%距离矩阵d
%======================
L=N;%sj0的长度
w=800;dai=1000;
%通过改良圈算法选取优良父代A
fork=1:w
c=randperm(L-2);
c1=[1,c+1,L];
flag=1;
whileflag>0
flag=0;
form=1:L-3
forn=m+2:L-1
ifd(c1(m),c1(n))+d(c1(m+1),c1(n+1))<d(c1(m),c1(m+1))+d(c1(n),c1(n+1))
flag=1;
c1(m+1:n)=c1(n:-1:m+1);
end
end
end
end
J(k,c1)=1:L;
end
J=J/L;
J(:,1)=0;J(:,L)=1;
rand('state',sum(clock));
%遗传算法实现过程
A=J;
fork=1:dai%产生0~1间随机数列进行编码
B=A;
c=randperm(w);
%交配产生子代B
fori=1:2:w
F=2+floor(100*rand(1));
temp=B(c(i),F:L);
B(c(i),F:L)=B(c(i+1),F:L);
B(c(i+1),F:L)=temp;
end;
%变异产生子代C
by=find(rand(1,w)<0.1);
iflength(by)==0
by=floor(w*rand(1))+1;
end
C=A(by,:);
L3=length(by);
forj=1:L3
bw=floor(1+fix(rand(1,3)*N));%产生1-N的3个随机数
bw=sort(bw);
C(j,:)=C(j,[1:bw(1)-1,bw(2)+1:bw(3),bw(1):bw(2),bw(3)+1:L]);
end
G=[A;B;C];
TL=size(G,1);
%在父代和子代中选择优良品种作为新的父代
[dd,IX]=sort(G,2);
temp=[];
temp(1:TL)=0;
forj=1:TL
fori=1:L-1
temp(j)=temp(j)+d(IX(j,i),IX(j,i+1));
end
end
[DZ,IZ]=sort(temp);
A=G(IZ(1:w),:);
end
path=IX(IZ(1),:)
%fori=1:length(path)
%path(i)=path(i)-1;
%end
%path=path(2:end-1);
lmin=0;l=0;
forj=1:(length(path)-1)
t1=path(j);t2=path(j+1);
l=d(t1,t2);
lmin=lmin+l;
end
xx=sj0(path,1);yy=sj0(path,2);
plot(xx,yy,'r-o');
axisequal
toc
代码亲自前几天还用来着,绝对可用
❸ 求基于遗传算法或粒子群算法的用MATLAB编程解决的选址问题的源程序,网上论文附录的程序都是萎的啊……
function [R_best,L_best,L_ave,Shortest_Route,Shortest_Length]=acatsp(C,NC_max,m,Alpha,Beta,Rho,Q)
%%=========================================================================
% ACATSP.m
% Ant Colony Algorithm for Traveling Salesman Problem
% GreenSim团队原创作品,转载请注明
% Email:[email protected]
% GreenSim团队主页
% 欢迎访问GreenSim——算法仿真团队
%%-------------------------------------------------------------------------
%% 主要符号说明
%% C n个城市的坐标,n×2的矩阵
%% NC_max 最大迭代次数
%% m 蚂蚁个数
%% Alpha 表征信息素重要程度的参数
%% Beta 表征启发式因子重要程度的参数
%% Rho 信息素蒸发系数
%% Q 信息素增加强度系数
%% R_best 各代最佳路线
%% L_best 各代最佳路线的长度
%%=========================================================================
%%第一步:变量初始化
n=size(C,1);%*表示问题的规模(城市个数)
D=zeros(n,n);%D表示完全图的赋权邻接矩阵
for i=1:n
for j=1:n
if i~=j
D(i,j)=((C(i,1)-C(j,1))^2+(C(i,2)-C(j,2))^2)^0.5;
else
D(i,j)=eps;
end
D(j,i)=D(i,j);
end
end
Eta=1./D;%Eta为启发因子,这里设为距离的倒数
Tau=ones(n,n);%Tau为信息素矩阵
Tabu=zeros(m,n);%存储并记录路径的生成
NC=1;%迭代计数器
R_best=zeros(NC_max,n);%各代最佳路线
L_best=inf.*ones(NC_max,1);%各代最佳路线的长度
L_ave=zeros(NC_max,1);%各代路线的平均长度
while NC<=NC_max%停止条件之一:达到最大迭代次数
%%第二步:将m只蚂蚁放到n个城市上
Randpos=[];
for i=1:(ceil(m/n))
Randpos=[Randpos,randperm(n)];
end
Tabu(:,1)=(Randpos(1,1:m))';
%%第三步:m只蚂蚁按概率函数选择下一座城市,完成各自的周游
for j=2:n
for i=1:m
visited=Tabu(i,1:(j-1));%已访问的城市
J=zeros(1,(n-j+1));%待访问的城市
P=J;%待访问城市的选择概率分布
Jc=1;
for k=1:n
if length(find(visited==k))==0
J(Jc)=k;
Jc=Jc+1;
end
end
%下面计算待选城市的概率分布
for k=1:length(J)
P(k)=(Tau(visited(end),J(k))^Alpha)*(Eta(visited(end),J(k))^Beta);
end
P=P/(sum(P));
%按概率原则选取下一个城市
Pcum=cumsum(P);
Select=find(Pcum>=rand);
to_visit=J(Select(1));
Tabu(i,j)=to_visit;
end
end
if NC>=2
Tabu(1,:)=R_best(NC-1,:);
end
%%第四步:记录本次迭代最佳路线
L=zeros(m,1);
for i=1:m
R=Tabu(i,:);
for j=1:(n-1)
L(i)=L(i)+D(R(j),R(j+1));
end
L(i)=L(i)+D(R(1),R(n));
end
L_best(NC)=min(L);
pos=find(L==L_best(NC));
R_best(NC,:)=Tabu(pos(1),:);
L_ave(NC)=mean(L);
NC=NC+1
%%第五步:更新信息素
Delta_Tau=zeros(n,n);
for i=1:m
for j=1:(n-1)
Delta_Tau(Tabu(i,j),Tabu(i,j+1))=Delta_Tau(Tabu(i,j),Tabu(i,j+1))+Q/L(i);
end
Delta_Tau(Tabu(i,n),Tabu(i,1))=Delta_Tau(Tabu(i,n),Tabu(i,1))+Q/L(i);
end
Tau=(1-Rho).*Tau+Delta_Tau;
%%第六步:禁忌表清零
Tabu=zeros(m,n);
end
%%第七步:输出结果
Pos=find(L_best==min(L_best));
Shortest_Route=R_best(Pos(1),:);
Shortest_Length=L_best(Pos(1));
subplot(1,2,1)
DrawRoute(C,Shortest_Route)
subplot(1,2,2)
plot(L_best)
hold on
plot(L_ave)
function DrawRoute(C,R)
%%====================================================================
%% DrawRoute.m
%% 画路线图的子函数
%%--------------------------------------------------------------------
%% C Coordinate 节点坐标,由一个N×2的矩阵存储
%% R Route 路线
%%====================================================================
N=length(R);
scatter(C(:,1),C(:,2));
hold on
plot([C(R(1),1),C(R(N),1)],[C(R(1),2),C(R(N),2)])
hold on
for ii=2:N
plot([C(R(ii-1),1),C(R(ii),1)],[C(R(ii-1),2),C(R(ii),2)])
hold on
end
❹ matlab遗传算法
首先,建立自定义函数,ga1_fun。m
function f = ga1_fun(x)
%题目是min f(x)=e^x1(4x1^2+2x2^2+4x1x2+2x2+1)
%s.t. 1.5+x1x2-x1-x2≤0,-x1x2≤10
if (1.5+x(1)*x(2)-x(1)-x(2)>0|-x(1)*x(2)>10)
f=100;
else
f=exp(x(1))*(4*x(1)^2+2*x(2)^2+4*x(1)*x(2)+2*x(2)+1);
end
然后,执行下列命专令
[x,f]=ga(@属ga1_fun,2)
运行结果:
❺ 遗传算法求最短路径的matlab程序,急求!!
^function [path, totalCost, farthestPreviousHop, farthestNextHop] = dijkstra(n, netCostMatrix, s, d, farthestPreviousHop, farthestNextHop)
% path: the list of nodes in the path from source to destination;
% totalCost: the total cost of the path;
% farthestNode: the farthest node to reach for each node after performing
% the routing;
% n: the number of nodes in the network;
% s: source node index;
% d: destination node index;
% clear;
% noOfNodes = 50;
% rand('state', 0);
% figure(1);
% clf;
% hold on;
% L = 1000;
% R = 200; % maximum range;
% netXloc = rand(1,noOfNodes)*L;
% netYloc = rand(1,noOfNodes)*L;
% for i = 1:noOfNodes
% plot(netXloc(i), netYloc(i), '.');
% text(netXloc(i), netYloc(i), num2str(i));
% for j = 1:noOfNodes
% distance = sqrt((netXloc(i) - netXloc(j))^2 + (netYloc(i) - netYloc(j))^2);
% if distance = R
% matrix(i, j) = 1; % there is a link;
% line([netXloc(i) netXloc(j)], [netYloc(i) netYloc(j)], 'LineStyle', ':');
% else
% matrix(i, j) = inf;
% end;
% end;
% end;
%
%
% activeNodes = [];
% for i = 1:noOfNodes,
% % initialize the farthest node to be itself;
% farthestPreviousHop(i) = i; % used to compute the RTS/CTS range;
% farthestNextHop(i) = i;
% end;
%
% [path, totalCost, farthestPreviousHop, farthestNextHop] = dijkstra(noOfNodes, matrix, 1, 15, farthestPreviousHop, farthestNextHop);
% path
% totalCost
% if length(path) ~= 0
% for i = 1:(length(path)-1)
% line([netXloc(path(i)) netXloc(path(i+1))], [netYloc(path(i)) netYloc(path(i+1))], 'Color','r','LineWidth', 0.50, 'LineStyle', '-.');
% end;
% end;
% hold off;
% return;
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
% all the nodes are un-visited;
visited(1:n) = 0;
distance(1:n) = inf; % it stores the shortest distance between each node and the source node;
parent(1:n) = 0;
distance(s) = 0;
for i = 1:(n-1),
temp = [];
for h = 1:n,
if visited(h) == 0 % in the tree;
temp=[temp distance(h)];
else
temp=[temp inf];
end
end;
[t, u] = min(temp); % it starts from node with the shortest distance to the source;
visited(u) = 1; % mark it as visited;
for v = 1:n, % for each neighbors of node u;
if ( ( netCostMatrix(u, v) + distance(u)) distance(v) )
distance(v) = distance(u) + netCostMatrix(u, v); % update the shortest distance when a shorter path is found;
parent(v) = u; % update its parent;
end;
end;
end;
path = [];
if parent(d) ~= 0 % if there is a path!
t = d;
path = [d];
while t ~= s
p = parent(t);
path = [p path];
if netCostMatrix(t, farthestPreviousHop(t)) netCostMatrix(t, p)
farthestPreviousHop(t) = p;
end;
if netCostMatrix(p, farthestNextHop(p)) netCostMatrix(p, t)
farthestNextHop(p) = t;
end;
t = p;
end;
end;
totalCost = distance(d);
return;
❻ 遗传算法 MATLABA 程序 选址问题
问题解决了吗?说实话你提的问题,用分是解决不了的,因为分是虚的,现在网上好多人给别人解决问题都是要钱的。
❼ 求一个用matlab编程遗传算法的程序,以确定一个图形的大致范围的,谢谢!
可以调用遗传算法工具箱。最好给个例子。谢谢。答好了可以追加20分。问题我给你查了一下,网上暂时找不到合适的matlab代码,相关的文献还是有的。
❽ 关于遗传算法的应用--物流中心选址问题
这个就是利用GA解决TSP问题,解决耗费最小的优化问题。
❾ Matlab遗传算法“选择”的程序一小段,求解
function u1=select(u)
%u是输入,u1是输出
%选择函数
%从i等于1到10计算适应度函数赋值给y
for i=1:10
y(i)=syd(u(i,:));
end
%求y的和
F=sum(y);
%并将适应度函数赋值除以他的和
P=y/F;
s=0;
%Q为累计概率
for i=1:10
s=s+P(i);
Q(i)=s;
end
%找到y中的最大值的值m和位置I
[m,I]=max(y);
取输入的u总I的解赋值给u1中第9个解的位置
u1(9,:)=u(I,:);
取输入的u总I的解赋值给u1中第10个解的位置
u1(10,:)=u(I,:);
%得到一个8行1列的随机数(0-1之间)
r=rand(8,1);
%对应i等于1到8
for i=1:8
%如果r的第i个随机数小于Q的第一个值
if r(i)<Q(1)
%u的第一个解赋值给u1的第i个解
u1(i,:)=u(1,:);
%否则如果r的第i个随机数大于Q的第一个值,并且r的第i个随机数大于Q的第二个值
elseif r(i)>=Q(1)& r(i)<Q(2)
%u的第二个解赋值给u1的第i个解
u1(i,:)=u(2,:);
elseif r(i)>=Q(2)& r(i)<Q(3)
u1(i,:)=u(3,:);
elseif r(i)>=Q(3)& r(i)<Q(4)
u1(i,:)=u(4,:);
elseif r(i)>=Q(4)&r(i)<Q(5)
u1(i,:)=u(5,:);
elseif r(i)>=Q(5)&r(i)<Q(6)
u1(i,:)=u(6,:);
elseif r(i)>=Q(6)&r(i)<Q(7)
u1(i,:)=u(7,:);
elseif r(i)>=Q(7)&r(i)<Q(8)
u1(i,:)=u(8,:);
elseif r(i)>=Q(8)&r(i)<Q(9)
u1(i,:)=u(9,:);
else
u1(i,:)=u(10,:);
end
end