亚洲欧美第一页_禁久久精品乱码_粉嫩av一区二区三区免费野_久草精品视频

? 歡迎來到蟲蟲下載站! | ?? 資源下載 ?? 資源專輯 ?? 關(guān)于我們
? 蟲蟲下載站

?? example43_run_a.m

?? 神經(jīng)網(wǎng)絡(luò)VC++代碼 人工神經(jīng)網(wǎng)絡(luò)原理及仿真實(shí)例.
?? M
?? 第 1 頁 / 共 5 頁
字號(hào):
                     if nargin < 3, A = [];
                     end, end, end, end, end, end, end, end

% Set up constant strings
medium =  'medium-scale: active-set';
large = 'large-scale';

if nargout > 4
   computeLambda = 1;
else 
   computeLambda = 0;
end

% Options setup
largescale = isequal(optimget(options,'LargeScale',defaultopt,'fast'),'on');
diagnostics = isequal(optimget(options,'Diagnostics',defaultopt,'fast'),'on');
switch optimget(options,'Display',defaultopt,'fast')
case {'off', 'none'}
   verbosity = 0;
case 'iter'
   verbosity = 2;
case 'final'
   verbosity = 1;
case 'testing'
   verbosity = Inf;
otherwise
   verbosity = 1;
end
mtxmpy = optimget(options,'HessMult',defaultopt,'fast');
% check if name clash
if isequal(mtxmpy,'hmult')
   warnstr = sprintf('%s\n%s\n%s\n', ...
            'Potential function name clash with a Toolbox helper function:',...
            'Use a name besides ''hmult'' for your HessMult function to',...
            'avoid errors or unexpected results.');
   warning(warnstr)
end

% Set the constraints up: defaults and check size
[nineqcstr,numberOfVariablesineq]=size(A);
[neqcstr,numberOfVariableseq]=size(Aeq);
if isa(H,'double') & ( isempty(mtxmpy) )
   lengthH = length(H);
else % HessMult in effect, so H can be anything
   lengthH = 0;
end

numberOfVariables = ...
    max([length(f),lengthH,numberOfVariablesineq,numberOfVariableseq]); % In case A or Aeq is empty
ncstr = nineqcstr + neqcstr;

if isempty(f), f=zeros(numberOfVariables,1); end
if isempty(A), A=zeros(0,numberOfVariables); end
if isempty(B), B=zeros(0,1); end
if isempty(Aeq), Aeq=zeros(0,numberOfVariables); end
if isempty(Beq), Beq=zeros(0,1); end

% Expect vectors
f=f(:);
B=B(:);
Beq=Beq(:);

if ~isequal(length(B),nineqcstr)
    error('The number of rows in A must be the same as the length of b.')
elseif ~isequal(length(Beq),neqcstr)
    error('The number of rows in Aeq must be the same as the length of beq.')
elseif ~isequal(length(f),numberOfVariablesineq) & ~isempty(A)
    error('The number of columns in A must be the same as the length of f.')
elseif ~isequal(length(f),numberOfVariableseq) & ~isempty(Aeq)
    error('The number of columns in Aeq must be the same as the length of f.')
end

[X0,lb,ub,msg] = checkbounds(X0,lb,ub,numberOfVariables);
if ~isempty(msg)
   exitflag = -1;
   output = []; X=X0; fval = []; lambda = [];
   if verbosity > 0
      disp(msg)
   end
   return
end

caller = 'quadprog';
% Check out H and make sure it isn't empty or all zeros
if isa(H,'double') & isempty(mtxmpy)
   if  norm(H,'inf')==0 | isempty(H)
      H=[]; 
      % Really a lp problem
      caller = 'linprog';
      warning('Hessian is empty or all zero; calling LINPROG');
      [X,fval,exitflag,output,lambda]=linprog(f,A,B,Aeq,Beq,lb,ub,X0,options);
      return
   else
      % Make sure it is symmetric
      if norm(H-H',inf) > eps
         if verbosity > -1
            warning('Your Hessian is not symmetric.  Resetting H=(H+H'')/2')
         end
         H = (H+H')*0.5;
      end
   end
end

% Use large-scale algorithm or not?
% Determine which algorithm and make sure problem matches.

%    If any inequalities, 
%    or both equalities and bounds, 
%    or more equalities than variables,
%    or no equalities and no bounds and no inequalities
%    or asked for active set (~largescale) then call qpsub
if ( (nineqcstr > 0) | ...
      ( neqcstr > 0 & (sum(~isinf(ub))>0 | sum(~isinf(lb)) > 0)) | ...
      (neqcstr > numberOfVariables) | ...
      (neqcstr==0 & nineqcstr==0 & ... 
          all(eq(ub, inf)) & all(eq(lb, -inf))) | ...  % unconstrained
      ~largescale)
   % (has linear inequalites  OR both equalities and bounds) OR 
   % ~largescale, then call active-set code
   output.algorithm = medium;
%    if largescale  & ...
%          (  issparse(H)  | issparse(A) | issparse(Aeq) )% asked for sparse
%       warnstr = sprintf('%s\n%s\n', ...
%          'This problem formulation not yet available for sparse matrices.',...
%          'Converting to full matrices and switching to medium-scale method.');
%       warning(warnstr);
%    elseif largescale % and didn't ask for sparse
%          warning(['Large-scale method does not currently solve this problem formulation,',...
%                sprintf('\n'), 'switching to medium-scale method.',sprintf('\n')])
%       
%    end
   if ~isa(H,'double') | ( ~isempty(mtxmpy) ) 
      error('H must be specified explicitly for medium-scale algorithm: cannot use HessMult option.');
   end
   H = full(H); A = full(A); Aeq = full(Aeq);
else % call sqpmin when just bounds or just equalities
   output.algorithm = large;
   if isempty(mtxmpy) 
     H = sparse(H);
   end
   A = sparse(A); Aeq = sparse(Aeq);
end

if diagnostics 
   % Do diagnostics on information so far
   gradflag = []; hessflag = []; line_search=[];
   constflag = 0; gradconstflag = 0; non_eq=0;non_ineq=0;
   lin_eq=size(Aeq,1); lin_ineq=size(A,1); XOUT=ones(numberOfVariables,1);
   funfcn{1} = [];ff=[]; GRAD=[];HESS=[];
   confcn{1}=[];c=[];ceq=[];cGRAD=[];ceqGRAD=[];
   msg = diagnose('quadprog',output,gradflag,hessflag,constflag,gradconstflag,...
      line_search,options,defaultopt,XOUT,non_eq,...
      non_ineq,lin_eq,lin_ineq,lb,ub,funfcn,confcn,ff,GRAD,HESS,c,ceq,cGRAD,ceqGRAD);
end

% if any inequalities, or both equalities and bounds, or more equalities than bounds,
%    or asked for active set (~largescale) then call qpsub
if isequal(output.algorithm, medium)
   if isempty(X0), 
      X0=zeros(numberOfVariables,1); 
   end
   [X,lambdaqp,exitflag,output]= ...
      qpsub(H,f,[Aeq;A],[Beq;B],lb,ub,X0,neqcstr,...
      verbosity,caller,ncstr,numberOfVariables,options,defaultopt); 
   output.algorithm = medium; % have to reset since call to qpsub obliterates
   
elseif isequal(output.algorithm,large)  % largescale: call sqpmin when just bounds or just equalities
   [X,fval,output,exitflag,lambda]=...
      sqpmin(f,H,X0,Aeq,Beq,lb,ub,verbosity,options,defaultopt,computeLambda,varargin{:});
   
   if exitflag == -2  % Problem not handled by sqpmin at this time
      if largescale  & ( issparse(H) | issparse(A) | issparse(Aeq) )% asked for sparse
         warnstr = sprintf('%s\n%s\n', ...
         'This problem formulation not yet available for sparse matrices.',...
         'Converting to full matrices and switching to medium-scale method.');
         warning(warnstr);
      elseif largescale
         warning(['Large-scale method does not currently solve this problem formulation,',...
               sprintf('\n'), 'switching to medium-scale method.',sprintf('\n')])
      end
      
      if isempty(X0), 
         X0=zeros(numberOfVariables,1); 
      end
      output.algorithm = medium;
      if ~isa(H,'double') | ( ~isempty(mtxmpy)  ) 
        error('H must be specified explicitly for medium-scale algorithm: cannot use HessMult option.');
      end
      H = full(H); A = full(A); Aeq = full(Aeq);
      
      [X,lambdaqp,exitflag,output]= ...
         qpsub(H,f,[Aeq;A],[Beq;B],lb,ub,X0,neqcstr,...
         verbosity,caller,ncstr,numberOfVariables,options,defaultopt);
      output.algorithm = medium; % have to reset since call to qpsub obliterates
   end
end


if isequal(output.algorithm , medium)
   fval = 0.5*X'*(H*X)+f'*X; 
   llb = length(lb); 
   lub = length(ub);
   lambda.lower = zeros(llb,1);
   lambda.upper = zeros(lub,1);
   arglb = ~isinf(lb); lenarglb = nnz(arglb);
   argub = ~isinf(ub); lenargub = nnz(argub);
   lambda.eqlin = lambdaqp(1:neqcstr,1);
   lambda.ineqlin = lambdaqp(neqcstr+1:neqcstr+nineqcstr,1);
   lambda.lower(arglb) = lambdaqp(neqcstr+nineqcstr+1:neqcstr+nineqcstr+lenarglb);
   lambda.upper(argub) = lambdaqp(neqcstr+nineqcstr+lenarglb+1: ...
                                  neqcstr+nineqcstr+lenarglb+lenargub);
   
   output.firstorderopt=[];
   output.cgiterations =[];
   
   if verbosity > 0
      if ( exitflag ==1 )
         disp('Optimization terminated successfully.');   
      end
      if ( exitflag == 2)
         % do some sort of check here to see how unreliable
         disp('Optimization completed.'); 
      end
      if (exitflag ==0)
         disp('Maximum number of iterations exceeded;')
         disp('   increase options.MaxIter')
      end
      
   end
end


function errstring = consist(model, type, inputs, outputs)

errstring = '';

% If type string is not empty
if ~isempty(type)
  % First check that model has type field
  if ~isfield(model, 'type')
    errstring = 'Data structure does not contain type field';
    return
  end
  % Check that model has the correct type
  s = model.type;
  if ~strcmp(s, type)
    errstring = ['Model type ''', s, ''' does not match expected type ''',...
	type, ''''];
    return
  end
end

% If inputs are present, check that they have correct dimension
if nargin > 2
  if ~isfield(model, 'nin')
    errstring = 'Data structure does not contain nin field';
    return
  end

  data_nin = size(inputs, 2);
  if model.nin ~= data_nin
    errstring = ['Dimension of inputs ', num2str(data_nin), ...
	' does not match number of model inputs ', num2str(model.nin)];
    return
  end
end

% If outputs are present, check that they have correct dimension
if nargin > 3
  if ~isfield(model, 'nout')
    errstring = 'Data structure does not conatin nout field';
    return
  end
  data_nout = size(outputs, 2);
  if model.nout ~= data_nout
    errstring = ['Dimension of outputs ', num2str(data_nout), ...
	' does not match number of model outputs ', num2str(model.nout)];
    return
  end

% Also check that number of data points in inputs and outputs is the same
  num_in = size(inputs, 1);
  num_out = size(outputs, 1);
  if num_in ~= num_out
    errstring = ['Number of input patterns ', num2str(num_in), ...
	' does not match number of output patterns ', num2str(num_out)];
    return
  end
end

function net = svm(nin, kernel, kernelpar, C, use2norm, qpsolver, qpsize)

%

% 

if nargin < 7,
  qpsize = 50;
end
if nargin < 6,
  qpsolver = '';
end
if nargin < 5,
  use2norm = 0;
end
if nargin < 4,
  C = 1;
end
if nargin < 3,
  kernelpar = [];
end

net.type = 'svm';
net.nin = nin;
net.nout = 1;
net.kernel = kernel;
net.kernelpar = kernelpar;
net.c = C;
net.use2norm = use2norm;

net.nbexamples = 0;
net.alpha = [];
net.svcoeff = [];
net.sv = [];
net.svind = [];
net.bias = [];
net.normalw = [];

net.qpsolver = qpsolver;
net.qpsize = qpsize;
net.alphatol = 1e-2;
net.kkttol = 5e-2;
net.chunksize = 500;
%     'chunksize' = Large matrix operations (for example when evaluating
%       the kernel functions) are split up into submatrices with maximum
%       size [NET.chunksize, NET.chunksize]. Default value: 500
net.recompute = Inf;
%     'recompute' = During training, the SVM outputs are updated
%       iteratively. After NET.recompute iterations the SVM outputs are
%       built again from scratch. Lower this when high precision is required.


function [net, CVErr, paramSeq] = svmcv(net, X, Y, range, step, nfold, Xv, Yv, dodisplay)

% 

% Check arguments for consistency
errstring = consist(net, 'svm', X, Y);
if ~isempty(errstring);
  error(errstring);
end
if nargin<9,
  dodisplay = 1;
end
if nargin<8,
  Xv = [];
end
if nargin<7,
  Yv = [];
end
if nargin<6,
  nfold = 10;
end
if (~isempty(Xv)) & (~isempty(Yv)),
  errstring = consist(net, 'svm', Xv, Yv);
  if ~isempty(errstring);
    error(errstring);
  end
  if (nfold~=1),
    error('Input parameters XV and YV may only be used with NFOLD==1');
  end
end
if nargin<5,
  step = 0;
end

range = range(:)';
N = size(X, 1);
if N<nfold,
  error('At least NFOLD (default 10) training examples must be given');
end

if (length(range)>2) | isempty(step),
  % If range parameter has more than only min/max entries: Use this as
  % the sequence of parameters to test
  paramSeq = range;
else
  paramSeq = [];
  switch net.kernel
    case 'rbf'
      if step==0,
        step = sqrt(2);
      end
    % Multiplicative update, step size < 1 : start with max value
    if abs(step)<1,
      param = max(range);
      while (param>=min(range)),
        paramSeq = [paramSeq param];
        param = param*abs(step);
      end
    else
      % Multiplicative update, step size > 1 : start with min value
      param = min(range);

?? 快捷鍵說明

復(fù)制代碼 Ctrl + C
搜索代碼 Ctrl + F
全屏模式 F11
切換主題 Ctrl + Shift + D
顯示快捷鍵 ?
增大字號(hào) Ctrl + =
減小字號(hào) Ctrl + -
亚洲欧美第一页_禁久久精品乱码_粉嫩av一区二区三区免费野_久草精品视频
一区二区欧美国产| 91福利社在线观看| 一区2区3区在线看| 国产精品麻豆网站| 日本一区二区综合亚洲| 精品国产免费人成在线观看| 欧美久久一区二区| 懂色av噜噜一区二区三区av| 天天av天天翘天天综合网色鬼国产 | 日韩免费高清av| av成人老司机| 国模冰冰炮一区二区| 另类小说一区二区三区| av激情综合网| 日本韩国一区二区三区| 欧美电视剧免费全集观看| 国产精品久久久久久久久动漫| 亚洲综合在线电影| 麻豆成人久久精品二区三区小说| 国产精品91一区二区| 成人国产亚洲欧美成人综合网| 成人激情黄色小说| 国产高清精品久久久久| 美女一区二区视频| gogo大胆日本视频一区| 26uuu欧美| 日韩午夜在线观看| 91久久精品网| 日韩女优av电影| 日韩av中文在线观看| 国产高清不卡一区二区| 91精品国产综合久久久久| 最好看的中文字幕久久| 日本不卡高清视频| 色婷婷综合激情| 中文一区在线播放| 免费成人在线网站| 欧美日韩成人激情| 一区二区三区免费看视频| 亚洲精品国产品国语在线app| 男女性色大片免费观看一区二区| 色综合天天性综合| 久久精品亚洲精品国产欧美| 婷婷丁香久久五月婷婷| av电影一区二区| 久久众筹精品私拍模特| 日韩精品亚洲一区| 在线观看网站黄不卡| 中文在线资源观看网站视频免费不卡| 免费不卡在线观看| 欧美日韩dvd在线观看| 亚洲另类一区二区| 成人午夜视频福利| 久久久久久久久免费| 喷水一区二区三区| 成人黄页在线观看| 国产一区二区在线免费观看| 国产精品福利影院| 99国内精品久久| 亚洲视频一区在线| 成人一级片网址| 国产喷白浆一区二区三区| 色综合天天狠狠| 国产精品美女久久福利网站| 国产盗摄女厕一区二区三区 | 麻豆一区二区99久久久久| 欧洲另类一二三四区| 亚洲男人的天堂在线aⅴ视频| 国产成人丝袜美腿| 国产日本欧美一区二区| 福利一区二区在线| 国产欧美综合色| 国产成人精品综合在线观看| 欧美在线播放高清精品| 午夜伦欧美伦电影理论片| 亚洲靠逼com| 欧美在线免费视屏| 婷婷综合另类小说色区| 精品久久久久av影院| 成人国产亚洲欧美成人综合网| 亚洲日韩欧美一区二区在线| 日韩亚洲电影在线| 成人av电影免费在线播放| 午夜一区二区三区视频| 欧美激情综合五月色丁香| 久久er99热精品一区二区| 色综合久久综合网97色综合| 亚洲最新视频在线播放| 欧美日韩精品一区二区三区蜜桃 | 国产一区激情在线| 久久精品视频免费| 成人免费视频视频在线观看免费 | 99国产精品国产精品久久| 亚洲日本在线天堂| 欧美美女喷水视频| 蜜桃视频一区二区三区| 久久蜜桃av一区二区天堂 | 中文字幕中文字幕中文字幕亚洲无线| 99在线精品免费| 亚洲综合在线视频| 日韩欧美中文字幕制服| 国产成人午夜视频| 亚洲欧美日韩在线不卡| 3d成人动漫网站| 国产成人在线观看| 亚洲一区二区三区美女| 日韩免费视频一区| 精品国产一区久久| 国产精品1区2区3区在线观看| 国产精品久久免费看| 欧美午夜精品电影| 久草中文综合在线| 日韩一区日韩二区| 3atv在线一区二区三区| 国产成人av在线影院| 一级女性全黄久久生活片免费| 欧美刺激脚交jootjob| aaa亚洲精品| 日韩av一级电影| 国产精品超碰97尤物18| 日韩一级黄色大片| 99国内精品久久| 麻豆国产精品一区二区三区| 国产精品久久久久久久久免费相片| 欧美日韩精品一区二区| 国产成人免费在线观看| 亚洲午夜在线视频| 中文子幕无线码一区tr| 欧美一区二区三区四区久久| 成人激情视频网站| 久久99精品久久久| 亚洲成人免费av| 国产精品国产三级国产aⅴ中文 | 久久不见久久见免费视频1| 亚洲欧美日本韩国| 久久精品人人做| 欧美精品免费视频| 色猫猫国产区一区二在线视频| 麻豆成人久久精品二区三区红| 亚洲视频在线一区观看| 久久亚洲私人国产精品va媚药| 在线视频亚洲一区| 风间由美中文字幕在线看视频国产欧美| 亚洲国产另类av| 国产精品的网站| 精品福利二区三区| 3d成人动漫网站| 日本高清免费不卡视频| 丰满放荡岳乱妇91ww| 麻豆极品一区二区三区| 亚洲国产色一区| 亚洲欧洲另类国产综合| 久久久精品2019中文字幕之3| 91精品国产欧美一区二区| 在线免费视频一区二区| 99久久国产综合精品女不卡| 国产在线视频一区二区三区| 日本vs亚洲vs韩国一区三区二区| 亚洲激情在线激情| 日韩一区在线看| 亚洲国产精品ⅴa在线观看| 26uuu另类欧美亚洲曰本| 91精品国产福利| 欧美日韩一区三区| 在线日韩国产精品| 91香蕉国产在线观看软件| 丰满少妇久久久久久久| 日韩欧美一级片| 91精品视频网| 91麻豆精品久久久久蜜臀| 欧美日韩中字一区| 欧美在线免费观看亚洲| 91成人看片片| 欧洲生活片亚洲生活在线观看| 91久久精品国产91性色tv| 99天天综合性| 色诱视频网站一区| 色噜噜狠狠色综合中国 | 亚洲国产综合91精品麻豆| 一区二区三区在线免费视频| 亚洲另类春色校园小说| 亚洲女人****多毛耸耸8| 亚洲日本在线观看| 亚洲美女淫视频| 一区二区三区国产| 有坂深雪av一区二区精品| 亚洲在线视频网站| 午夜激情综合网| 日本亚洲免费观看| 青青草国产精品97视觉盛宴| 日本不卡123| 国产一区二区在线电影| 国产精品456露脸| av不卡在线播放| 在线观看av不卡| 91精品免费观看| 日韩免费观看高清完整版| 26uuu国产日韩综合| 久久久久成人黄色影片| 国产精品国产三级国产普通话三级|