當前位置:首頁 » 遺傳因素 » matlab遺傳演算法選址

matlab遺傳演算法選址

發布時間: 2021-03-21 18:26:14

❶ 誰有基於遺傳演算法的物流中心選址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

熱點內容
法國電影小男孩在農場遇到一隻白狗 發布:2024-08-19 08:36:47 瀏覽:594
微光上有什麼恐怖片 發布:2024-08-19 05:25:40 瀏覽:915
穿越香港鬼片滅鬼的小說 發布:2024-08-19 03:36:10 瀏覽:833
惡之花都敏秀姐姐扮演者 發布:2024-08-19 02:22:07 瀏覽:321
thai好看電影 發布:2024-08-18 11:34:37 瀏覽:795
電影內容女的是傻子容易尿褲子,男的很窮單身漢 發布:2024-08-18 10:31:36 瀏覽:129
雙機巨幕廳和4k廳哪個好 發布:2024-08-18 10:18:41 瀏覽:818
日本僵屍片上世紀 發布:2024-08-18 07:32:00 瀏覽:537
怪物 韓國電影在線 發布:2024-08-18 03:49:17 瀏覽:491
第九區一樣的 發布:2024-08-17 23:16:05 瀏覽:528