diff --git a/@sdpvar/any.m b/@sdpvar/any.m index 3904b041..53740f65 100644 --- a/@sdpvar/any.m +++ b/@sdpvar/any.m @@ -1,9 +1,6 @@ function anys = any(x) %ANY (overloaded) -% Author Johan Löfberg -% $Id: any.m,v 1.2 2006-07-26 20:17:57 joloef Exp $ - x_base = x.basis; anys = full(sum(abs(x.basis),2)>0); anys = reshape(anys,x.dim(1),x.dim(2)); \ No newline at end of file diff --git a/@sdpvar/domain.m b/@sdpvar/domain.m index c9416d52..36131d50 100644 --- a/@sdpvar/domain.m +++ b/@sdpvar/domain.m @@ -1,4 +1,4 @@ -function Y=plot(varargin) +function Y=domain(varargin) %DOMAIN Extract domain for PWA variable % Fast version for plotting simple PWA objects diff --git a/@sdpvar/poly.m b/@sdpvar/poly.m index 3b58b570..bde76724 100644 --- a/@sdpvar/poly.m +++ b/@sdpvar/poly.m @@ -12,8 +12,6 @@ % % See also DET -% Author Anders Helmersson, Johan Löfberg - [n, m] = size (A); if n ~= m, error ('A must be square'); end; diff --git a/@sdpvar/sumsum.m b/@sdpvar/sumsum.m index 074c67cb..d9237848 100644 --- a/@sdpvar/sumsum.m +++ b/@sdpvar/sumsum.m @@ -1,4 +1,4 @@ -function Y=sum(Y) +function Y=sumsum(Y) %SUM (overloaded) Y.basis = sum(Y.basis,1); diff --git a/@sdpvar/variablereplace.m b/@sdpvar/variablereplace.m index fe3fca83..a657a2d2 100644 --- a/@sdpvar/variablereplace.m +++ b/@sdpvar/variablereplace.m @@ -1,4 +1,4 @@ -function y = replace(y,oldVar,newVar) +function y = variablereplace(y,oldVar,newVar) var = y.lmi_variables; diff --git a/extras/@lmi/chebyball.m b/extras/@lmi/chebyball.m index 8a91df9a..d0ea6ce2 100644 --- a/extras/@lmi/chebyball.m +++ b/extras/@lmi/chebyball.m @@ -11,9 +11,6 @@ % If only one output is requested, only the symbolic constraint is returned % C = chebyball(F) -% Author Johan Löfberg -% $Id: chebyball.m,v 1.1 2004-12-08 00:07:15 johanl Exp $ - [model,recoverdata,diagnostic,p] = export(F,[],[],[],[],0); if p.K.q(1) > 0 | p.K.s(1) > 0 | any(p.variabletype) | ~isempty(p.binary_variables) | ~isempty(p.integer_variables) error('Polytope can only be applied to linear elementwise constraints.') diff --git a/extras/@lmi/constraintclass.m b/extras/@lmi/constraintclass.m index 695499c9..8d02add4 100644 --- a/extras/@lmi/constraintclass.m +++ b/extras/@lmi/constraintclass.m @@ -1,9 +1,6 @@ function LIST = constraintclass(F,property) %CONSTRAINTCLASS Returns a list describing the constraints -% Author Johan Löfberg -% $Id: constraintclass.m,v 1.2 2005-02-04 10:10:26 johanl Exp $ - F = flatten(F); if isempty(F.clauses) LIST = []; diff --git a/extras/@lmi/envelope.m b/extras/@lmi/envelope.m index 30967c15..74d3eb6d 100644 --- a/extras/@lmi/envelope.m +++ b/extras/@lmi/envelope.m @@ -39,8 +39,6 @@ % plot(E,[x;u],[],[],sdpsettings('relax',1)) % xx = (-1:0.01:1);hold on;plot(xx,xx+sin(pi*xx),xx,4-xx.^2) -% Author Johan Löfberg - [aux1,aux2,aux3,p] = export(C,[],sdpsettings('solver','bmibnb')); if isempty(p) diff --git a/extras/@lmi/sizeOLD.m b/extras/@lmi/sizeOLD.m index d6fdd19f..5da40986 100644 --- a/extras/@lmi/sizeOLD.m +++ b/extras/@lmi/sizeOLD.m @@ -1,8 +1,8 @@ -function varargout=size(varargin) +function varargout=sizeOLD(varargin) %size Returns the number of inequalities and equalities % -% n = SIZE(F) Returns the number of inequalities -% [n,m] = SIZE(F) Returns the number of inequalities and equalities +% n = SIZEOLD(F) Returns the number of inequalities +% [n,m] = SIZEOLD(F) Returns the number of inequalities and equalities % % See also LMI, ADDLMI diff --git a/extras/@logdet/minus.m b/extras/@logdet/minus.m index 9de1bdfe..23cda476 100644 --- a/extras/@logdet/minus.m +++ b/extras/@logdet/minus.m @@ -47,40 +47,3 @@ Z.P = {Alog{:},Blog{:}}; Z.gain = [Again -Bgain]; -% function Z = minus(cx,P) -% %display Overloaded -% -% % Author Johan Löfberg -% % $Id: minus.m,v 1.4 2007-02-07 09:11:27 joloef Exp $ -% -% % Standard case c't-logdet(P) -% -% if isa(P,'logdet') % sdpvr - logdet -% -% if prod(size(cx))>1 -% error('Only scalar terms can be added to a logdet term'); -% end -% -% if isa(cx,'logdet') -% error('Logdet objects can only be added'); -% end -% -% Z = P; -% if isempty(P.cx) -% Z.cx = cx; -% else -% Z.cx = cx-P.cx; -% end -% Z.gain = -Z.gain; -% else % logdet - cx -% temp = cx; -% cx = P; -% P = temp; -% -% Z = P; -% if isempty(P.cx) -% Z.cx = -cx; -% else -% Z.cx = P.cx-cx; -% end -% end \ No newline at end of file diff --git a/extras/@logdet/plus.m b/extras/@logdet/plus.m index 481c2e31..55f922e8 100644 --- a/extras/@logdet/plus.m +++ b/extras/@logdet/plus.m @@ -46,34 +46,3 @@ Z.P = {Alog{:},Blog{:}}; Z.gain = [Again Bgain]; - -% function Z = plus(X,Y) -% %display Overloaded -% -% % Author Johan Löfberg -% % $Id: plus.m,v 1.5 2007-02-07 09:11:27 joloef Exp $ -% -% % LOGDET + SDPVAR -% if isa(Y,'logdet') -% Z = X; -% X = Y; -% Y = Z; -% end -% -% if prod(size(Y))>1 -% error('Only scalar terms can be added to a logdet term'); -% end -% -% if isa(Y,'logdet') -% Z = X; -% Z.P = {Z.P{:},Y.P{:}};%blkdiag(Z.P,Y.P); -% Z.gain = [X.gain Y.gain]; -% return -% end -% -% Z = X; -% if isempty(Z.cx) -% Z.cx = Y; -% else -% Z.cx = plus(Z.cx,Y); -% end \ No newline at end of file diff --git a/extras/@ncvar/integer.m b/extras/@ncvar/integer.m index f5d2afc1..f6a292ca 100644 --- a/extras/@ncvar/integer.m +++ b/extras/@ncvar/integer.m @@ -21,8 +21,5 @@ % % See also BINARY, SET, SDPVAR, INTVAR, BINVAR -% Author Johan Löfberg -% $Id: integer.m,v 1.1 2006-08-10 18:00:20 joloef Exp $ - x.typeflag = 7; x = lmi(x); \ No newline at end of file diff --git a/extras/RecoverNonlinearSolverSolution.m b/extras/RecoverNonlinearSolverSolution.m index 96be8d6b..f6b8c2e9 100644 --- a/extras/RecoverNonlinearSolverSolution.m +++ b/extras/RecoverNonlinearSolverSolution.m @@ -1,4 +1,4 @@ -function x = RecoverNonlinearSolversolution(model,xout); +function x = RecoverNonlinearSolverSolution(model,xout); if isempty(model.nonlinearindicies) x = xout(:); diff --git a/extras/addExponentialCone.m b/extras/addExponentialCone.m index 7439424a..040a355e 100644 --- a/extras/addExponentialCone.m +++ b/extras/addExponentialCone.m @@ -1,4 +1,4 @@ -function [data,cones,output] = adExponentialCone(data,cones,model) +function [data,cones,output] = addExponentialCone(data,cones,model) output.problem = 0; if ~isempty(model.evalMap) diff --git a/extras/bmilin.m b/extras/bmilin.m index f9d52af2..41f74c2a 100644 --- a/extras/bmilin.m +++ b/extras/bmilin.m @@ -24,10 +24,6 @@ % bmilin.maxiterls - Maximum number of iterations in line search [integer (10)] % bmilin.maxiter - Maximum number of iterations [integer (25)] -% Author Johan Löfberg -% $Id: bmilin.m,v 1.3 2005-04-29 08:05:01 joloef Exp $ - - disp('***********************************************') disp('') disp('Warning : This code is still under development') diff --git a/extras/compressfactors2.m b/extras/compressfactors2.m index ef16627f..71375347 100644 --- a/extras/compressfactors2.m +++ b/extras/compressfactors2.m @@ -1,8 +1,5 @@ function [constants,general,newsingles,newpairs] = compressfactors2(constants,general,singles,pairs) -% Author Johan Löfberg -% $Id: compressfactors2.m,v 1.1 2009-11-03 10:30:33 joloef Exp $ - newpairs = {}; taken = zeros(1,length(pairs)); for i = 1:length(pairs) @@ -13,14 +10,6 @@ if ~taken(i) for j = i+1:length(pairs) - % if ~isequal(pairs{i}.M,pairs{j}.M) - % if isequal(pairs{i}.M,pairs{j}.M',1) - % pairs{j}.M = pairs{i}.M; - % temp = pairs{j}.L; - % pairs{j}.L = pairs{j}.R'; - % pairs{j}.R = temp'; - % end - % end if isequal(pairs{i}.M,pairs{j}.M,1) if isequal(pairs{i}.L,pairs{j}.L) Lsameas = [Lsameas j]; diff --git a/extras/findulb_interval.m b/extras/findulb_interval.m index 5a97247a..e8d2ffae 100644 --- a/extras/findulb_interval.m +++ b/extras/findulb_interval.m @@ -1,4 +1,4 @@ -function [lb,ub,cand_rows] = findulb(F_struc,K) +function [lb,ub,cand_rows] = findulb_interval(F_struc,K) %FINDULB Internal function to extract upper and lower variable bounds % special code for the interval data case, to avoid overhead in the default diff --git a/extras/fmincon_funhessian.m b/extras/fmincon_funhessian.m index 1b205d73..1d08b42d 100644 --- a/extras/fmincon_funhessian.m +++ b/extras/fmincon_funhessian.m @@ -1,4 +1,4 @@ -function H = fmincon_fun(x,params,what) +function H = fmincon_funhessian(x,params,what) xevaled = zeros(1,length(params.interfacedata.c)); xevaled(params.linearindicies) = x; diff --git a/extras/matrixcoefficients.m b/extras/matrixcoefficients.m index 49e73cc7..c912f4ee 100644 --- a/extras/matrixcoefficients.m +++ b/extras/matrixcoefficients.m @@ -100,153 +100,3 @@ end p_base_parametric = stackcell(sdpvar(1,1),xx)'; end - - - -% -% -% -% -% -% function [base,v] = coefficients(p,x) -% %COEFFICIENTS Extract coefficients and monomials from polynomials -% % -% % [c,v] = COEFFICIENTS(p,x) extracts the coefficents -% % of a polynomial p(x) = c'*v(x) -% % -% % INPUT -% % p : SDPVAR object -% % x : SDPVAR object -% % -% % OUTPUT -% % c : SDPVAR object -% % v : SDPVAR object -% % -% % EXAMPLE -% % sdpvar x y s t -% % p = x^2+x*y*(s+t)+s^2+t^2; % define p(x,y), parameterized with s and t -% % [c,v] = coefficients(p,[x y]); -% % sdisplay([c v]) -% % -% % See also SDPVAR -% -% % Author Johan Löfberg -% % $Id: matrixcoefficients.m,v 1.4 2006-08-09 12:14:04 joloef Exp $ -% -% -% if length(p) > 1%size(p,2) > 1 -% error('Coefficents can only be applied to column vectors'); -% end -% -% allvar = depends(p); -% if nargin==1 -% xvar = allvar; -% x = recover(xvar); -% else -% xvar = depends(x); -% end -% -% pvar = recover(depends(p)); -% -% base = []; -% for i = 1:length(p) -% [bi{i},vi{i}] = coefficientsi(p(i),xvar,pvar,allvar); -% end -% -% % Fix the lengths of the basis to use same basis for all elements -% if length(bi)>1 -% allvars = []; -% for i = 1:length(bi) -% bivar{i} = getvariables(vi{i}); -% if isequal(vi{i}(1),1) -% bivar{i} = [0 bivar{i}]; -% end -% allvars = unique([allvars bivar{i}]); -% end -% v = recover(allvars); -% c = zeros(length(p),length(allvars))'; -% ci = []; -% cj = []; -% cv = []; -% for i = 1:length(bi) -% index = find(ismember(allvars,bivar{i})); -% ci = [ci index]; -% cj = [cj repmat(i,1,length(index))]; -% cv = [cv bi{i}']; -% end -% base = sparse(ci,cj,cv); -% else -% base = bi{1}; -% v = vi{1}; -% end -% -% -% function [base,v] = coefficientsi(p,xvar,pvar,allvar) -% -% % Try to debug this! -% t = setdiff(allvar,xvar); -% [exponent_p,p_base] = getexponentbase(p,pvar); -% ParametricIndicies = find(ismember(allvar,t)); -% % FIX : don't define it here, wait until sparser below. Speed!! -% tempbase = parameterizedbase(p,[],recover(t),ParametricIndicies,exponent_p,p_base); -% [i,j,k] = unique(full(exponent_p(:,find(~ismember(allvar,t)))),'rows'); -% %V = sparse(max(k),length(tempbase)); -% %for i = 1:max(k) -% % V(i,find(k==i)) = 1; -% %end -% V = sparse(1:length(k),k,1,length(tempbase),max(k))'; -% base = V*tempbase; -% if nargout == 2 -% keepthese = j(1:max(k)); -% v = recovermonoms(exponent_p(keepthese,find(~ismember(allvar,t))),recover(xvar)); -% end -% -% -% function p_base_parametric = parameterizedbase(p,z, params,ParametricIndicies,exponent_p,p_base) -% -% % Check for linear parameterization -% parametric_basis = exponent_p(:,ParametricIndicies); -% if all(sum(parametric_basis,2)==0) -% p_base_parametric = full(p_base(:)); -% return -% end -% if all(sum(parametric_basis,2)<=1) -% p_base_parametric = full(p_base(:)); -% n = length(p_base_parametric); -% ii = []; -% vars = []; -% js = sum(parametric_basis,1); -% for i = 1:size(parametric_basis,2) -% if js(i) -% j = find(parametric_basis(:,i)); -% ii = [ii j(:)']; -% vars = [vars repmat(i,1,js(i))]; -% end -% end -% k = setdiff1D(1:n,ii); -% if isempty(k) -% p_base_parametric = p_base_parametric.*sparse(ii,repmat(1,1,n),params(vars)); -% else -% pp = params(vars); % Must do this, bug in ML 6.1 (x=sparse(1);x([1 1]) gives different result in 6.1 and 7.0!) -% p_base_parametric = p_base_parametric.*sparse([ii k(:)'],repmat(1,1,n),[pp(:)' ones(1,1,length(k))]); -% end -% else -% % Bummer, nonlinear parameterization sucks... -% for i = 1:length(p_base) -% j = find(exponent_p(i,ParametricIndicies)); -% if ~isempty(j) -% temp = p_base(i); -% for k = 1:length(j) -% if exponent_p(i,ParametricIndicies(j(k)))==1 -% temp = temp*params(j(k)); -% else -% temp = temp*params(j(k))^exponent_p(i,ParametricIndicies(j(k))); -% end -% end -% xx{i} = temp; -% else -% xx{i} = p_base(i); -% end -% end -% p_base_parametric = stackcell(sdpvar(1,1),xx)'; -% end diff --git a/extras/pennlp_conhess.m b/extras/pennlp_conhess.m index eb3893d8..3d093e18 100644 --- a/extras/pennlp_conhess.m +++ b/extras/pennlp_conhess.m @@ -1,4 +1,4 @@ -function [nnz, row, col, val] = pennlp_fun(i,x) +function [nnz, row, col, val] = pennlp_conhess(i,x) try H = datasaver(6,x,i+1); diff --git a/extras/pennonm_callback_f.m b/extras/pennonm_callback_f.m index a989d9b0..68561112 100644 --- a/extras/pennonm_callback_f.m +++ b/extras/pennonm_callback_f.m @@ -1,4 +1,4 @@ -function f = ipopt_callback_f(x,model_in) +function f = pennonm_callback_f(x,model_in) global latest_x global latest_df diff --git a/extras/plotInternalModel.m b/extras/plotInternalModel.m index 8731b848..3791a28b 100644 --- a/extras/plotInternalModel.m +++ b/extras/plotInternalModel.m @@ -1,4 +1,4 @@ -function x_opt = PlotInternalModel(internalmodel,x,n,localindex,color,opts) +function x_opt = plotInternalModel(internalmodel,x,n,localindex,color,opts) % Code used by both lmi/plot and optimizer/plot if isempty(internalmodel.binary_variables) diff --git a/extras/recovernc.m b/extras/recovernc.m index 46a9ca7b..69418d65 100644 --- a/extras/recovernc.m +++ b/extras/recovernc.m @@ -1,4 +1,4 @@ -function varargout = recover(lmi_variables) +function varargout = recovernc(lmi_variables) %RECOVER Create NCVAR object using variable indicies if isempty(lmi_variables) diff --git a/extras/sedumi2dsdp5.m b/extras/sedumi2dsdp5.m index 34d04b62..a402a652 100644 --- a/extras/sedumi2dsdp5.m +++ b/extras/sedumi2dsdp5.m @@ -1,4 +1,4 @@ -function [b,AC] = sedumi2dsdp(F_struc,c,K) +function [b,AC] = sedumi2dsdp5(F_struc,c,K) %SEDUMI2DSDP5 Internal function to convert SeDuMi structure to format needed in DSDP 5 nvars = size(F_struc,2)-1; diff --git a/extras/setpolynomials.m b/extras/setpolynomials.m index 403c533d..4d9d2647 100644 --- a/extras/setpolynomials.m +++ b/extras/setpolynomials.m @@ -1,9 +1,6 @@ function setpolynomials %SETPOLYNOMIALS Internal function -% Author Johan Löfberg -% $Id: setpolynomials.m,v 1.3 2005-04-29 08:05:01 joloef Exp $ - solution = sdpvar('getSolution'); lmi_variables = solution.variables; opt_variables = solution.optvar; diff --git a/extras/solveequalities.m b/extras/solveequalities.m index cdf7c4f4..a46cb98e 100644 --- a/extras/solveequalities.m +++ b/extras/solveequalities.m @@ -1,9 +1,6 @@ function [x_equ,H,A_equ,b_equ,factors] = solveequalities(F_struc,K,unitary) %SOLVEEQUALITIES Internal function remove equality constraints -% Author Johan Löfberg -% $Id: solveequalities.m,v 1.17 2007-05-24 14:44:20 joloef Exp $ - % Extract the inequalities A_equ = F_struc(1:K.f,2:end); b_equ = -F_struc(1:K.f,1); @@ -14,16 +11,6 @@ factors = []; -% remove = find((~any(A_equ,2)) & (b_equ == 0)); -% if ~isempty(remove) -% A_equ = A_equ'; -% A_equ(:,remove) = []; -% A_equ = A_equ'; -% b_equ = b_equ'; -% b_equ(remove) = []; -% b_equ = b_equ'; -% end - if ~unitary % This code needs a clean up, and I need to take a course in numerical @@ -31,12 +18,6 @@ % Remove redundant constraints [L,U,P] = lu(A_equ); -% r = colspaces(U); -% if ~(length(r) == size(U,1)) -% b_equ = L\(P*b_equ); -% A_equ = U(r,:); -% b_equ = b_equ(r); -% end % Find a basis for the column space of A_equ [L,U,P] = lu(A_equ'); diff --git a/extras/ttimes.m b/extras/ttimes.m index cd1be6f7..85586d63 100644 --- a/extras/ttimes.m +++ b/extras/ttimes.m @@ -1,4 +1,4 @@ -function C = mptimes(A,B) +function C = ttimes(A,B) % TTIMES Tropical multiplication (max-plus algebra) % % C = TTIMES(A,B) Computes the tropical multiplication of the matrices A diff --git a/modules/global/convexhullConcave2D.m b/modules/global/convexhullConcave2D.m index 040e4d76..f6f93a9c 100644 --- a/modules/global/convexhullConcave2D.m +++ b/modules/global/convexhullConcave2D.m @@ -1,4 +1,4 @@ -function [Ax,Ay,b,K] = convexhullConcave(x1,f1,df1,x2,f2,df2,x3,f3,df3,x4,f4,df4,x5,f5,df5) +function [Ax,Ay,b,K] = convexhullConcave2D(x1,f1,df1,x2,f2,df2,x3,f3,df3,x4,f4,df4,x5,f5,df5) % x1-x4 corner points, 5 point in center % Lower bounds from tangents diff --git a/modules/global/kktqp.m b/modules/global/kktqp.m index 89a58871..c8cfbdc8 100644 --- a/modules/global/kktqp.m +++ b/modules/global/kktqp.m @@ -5,11 +5,7 @@ % the high-level KKT operator. This version is only kept for compatibility % reasons. % -% See also kkt - - -% Author Johan Löfberg -% $Id: kktqp.m,v 1.2 2008-06-10 14:47:59 joloef Exp $ +% See also KKT % ******************************** %% INITIALIZE DIAGNOSTICS IN YALMIP diff --git a/modules/global/presolveTrivialSDP.m b/modules/global/presolveTrivialSDP.m index e90b7b3c..36dc3fc3 100644 --- a/modules/global/presolveTrivialSDP.m +++ b/modules/global/presolveTrivialSDP.m @@ -1,4 +1,4 @@ -function p = presolveTrvialSDP(p) +function p = presolveTrivialSDP(p) x0 = ones(length(p.c),1); x0(find(p.lb == 0 & p.ub==0)) = 0; diff --git a/modules/global/presolve_implied_integer.m b/modules/global/presolve_implied_integer.m index 655b4d39..0a5082b9 100644 --- a/modules/global/presolve_implied_integer.m +++ b/modules/global/presolve_implied_integer.m @@ -1,4 +1,4 @@ -function p = preprocess_bilinear_bounds(p) +function p = presolve_implied_integer(p) if ~isempty(p.integer_variables) for i = 1:size(p.bilinears,1) diff --git a/modules/global/propagate_bounds_from_convex_quadratic.m b/modules/global/propagate_bounds_from_convex_quadratic.m index ac2276a5..0b388796 100644 --- a/modules/global/propagate_bounds_from_convex_quadratic.m +++ b/modules/global/propagate_bounds_from_convex_quadratic.m @@ -1,4 +1,4 @@ -function p = presolve_quadratic_psdbound(p) +function p = propagate_bounds_from_convex_quadratic(p) % Look for r >= (or ==) (x - c)^T Q (x - c) if p.K.f + p.K.l > 0 for i = 1:p.K.l + p.K.f diff --git a/modules/global/propagate_bounds_from_monomials.m b/modules/global/propagate_bounds_from_monomials.m index 860acb7d..2dd936a4 100644 --- a/modules/global/propagate_bounds_from_monomials.m +++ b/modules/global/propagate_bounds_from_monomials.m @@ -1,4 +1,4 @@ -function p = updatemonomialbounds(p); +function p = propagate_bounds_from_monomials(p) LU = [p.lb p.ub]; if ~isempty(p.bilinears) x = p.bilinears(:,2); diff --git a/modules/global/propagate_bounds_lp.m b/modules/global/propagate_bounds_lp.m index 86ba416f..3acc06f5 100644 --- a/modules/global/propagate_bounds_lp.m +++ b/modules/global/propagate_bounds_lp.m @@ -1,4 +1,4 @@ -function [p,feasible,vol_reduction,seen_x] = domain_reduction(p,upper,lower,lpsolver,xmin); +function [p,feasible,vol_reduction,seen_x] = propagate_bounds_lp(p,upper,lower,lpsolver,xmin); LU = [p.lb p.ub]; seen_x = {}; if ~p.options.bmibnb.lpreduce | ((size(p.lpcuts,1)==0) & (any(p.lb(p.linears)<-1e8) & any(p.ub(p.linears)>1e8))) diff --git a/modules/global/tightenbounds.m b/modules/global/tightenbounds.m index 51927aca..76c85af7 100644 --- a/modules/global/tightenbounds.m +++ b/modules/global/tightenbounds.m @@ -1,9 +1,6 @@ function [lb,ub,redundant,psstruct,infeasible] = tightenbounds(A,b,lb,ub,integer_variables,binary_variables,changed_bounds); %TIGHTENBOUNDS Internal function to perform bound tightening -% Author Johan Löfberg -% $Id: tightenbounds.m,v 1.1 2006-03-30 13:56:54 joloef Exp $ - % Simple bound pre-processing (paper by Savelsbergh) % No code optimization at all diff --git a/modules/moment/extractsolution.m b/modules/moment/extractsolution.m index b1898756..f5d903ab 100644 --- a/modules/moment/extractsolution.m +++ b/modules/moment/extractsolution.m @@ -11,9 +11,6 @@ % % See also SOLVEMOMENT, SDPSETTINGS -% Author Johan Löfberg -% $Id: extractsolution.m,v 1.1 2006-03-30 13:36:38 joloef Exp $ - moment = momentdata.moment; x = momentdata.x; monomials = momentdata.monomials; diff --git a/modules/moment/solvemoment.m b/modules/moment/solvemoment.m index 4f023755..7d983b48 100644 --- a/modules/moment/solvemoment.m +++ b/modules/moment/solvemoment.m @@ -38,11 +38,6 @@ % % See also SDPVAR, SET, SDPSETTINGS, SOLVESDP -% Author Johan Löfberg, Philipp Rostalski Update -% $Id: solvemoment.m,v 1.8 2007/05/28 09:09:42 joloef Exp $ -% -% Updated equality constraint handling, 2010/08/02 - if nargin ==0 help solvemoment return diff --git a/modules/parametric/mpt_appendmodel.m b/modules/parametric/mpt_appendmodel.m index 367b3869..5d1e29f4 100644 --- a/modules/parametric/mpt_appendmodel.m +++ b/modules/parametric/mpt_appendmodel.m @@ -1,4 +1,4 @@ -function model = savemptmodel(model,Pfinal,Pn,Fi,Gi,details); +function model = mpt_appendmodel(model,Pfinal,Pn,Fi,Gi,details); if length(Fi)>0 if length(model) == 0 diff --git a/modules/parametric/mpt_derive_bounds.m b/modules/parametric/mpt_derive_bounds.m index 0d42187e..d8a48bbb 100644 --- a/modules/parametric/mpt_derive_bounds.m +++ b/modules/parametric/mpt_derive_bounds.m @@ -1,4 +1,4 @@ -function [Matrices,infeasible] = derive_bounds(Matrices,options) +function [Matrices,infeasible] = mpt_derive_bounds(Matrices,options) A = [Matrices.G -Matrices.E]; b = [Matrices.W]; diff --git a/modules/parametric/mpt_detect_and_improve_bounds.m b/modules/parametric/mpt_detect_and_improve_bounds.m index 7b45bbc5..db59986e 100644 --- a/modules/parametric/mpt_detect_and_improve_bounds.m +++ b/modules/parametric/mpt_detect_and_improve_bounds.m @@ -1,4 +1,4 @@ -function [lb,ub,redundant] = detect_and_improve_bounds(Matrices,lb,ub,binary_var_index,options); +function [lb,ub,redundant] = mpt_detect_and_improve_bounds(Matrices,lb,ub,binary_var_index,options); A = [ Matrices.G -Matrices.E]; b = [ Matrices.W ]; diff --git a/modules/parametric/solvemp.m b/modules/parametric/solvemp.m index dfbfb176..5e51271d 100644 --- a/modules/parametric/solvemp.m +++ b/modules/parametric/solvemp.m @@ -37,9 +37,6 @@ % % See also PARAMETRIC, SET, SDPSETTINGS, YALMIPERROR -% Author Johan Löfberg -% $Id: solvemp.m,v 1.11 2007-08-17 13:17:16 joloef Exp $ - if nargin <= 3 ops = sdpsettings; end diff --git a/modules/robust/dilate2.m b/modules/robust/dilate2.m index f822b39a..f2634976 100644 --- a/modules/robust/dilate2.m +++ b/modules/robust/dilate2.m @@ -1,4 +1,4 @@ -function varargout = dilate(F,w) +function varargout = dilate2(F,w) % DILATE Derives a matrix dilation % % [G,H,M] = DILATE(X,w) where X is a symmetric variable derives the diff --git a/modules/robust/getFzxfromSET.m b/modules/robust/getFzxfromSET.m index 9214e0b8..4acf5776 100644 --- a/modules/robust/getFzxfromSET.m +++ b/modules/robust/getFzxfromSET.m @@ -1,4 +1,4 @@ -function [F0,Fz,Fx,Fxz] = getEF(F,z,x); +function [F0,Fz,Fx,Fxz] = getFzxfromSET(F,z,x) F = sdpvar(F); F0 = -getbasematrix(F,0); diff --git a/modules/robust/robustify.m b/modules/robust/robustify.m index babcd40b..e0ba666c 100644 --- a/modules/robust/robustify.m +++ b/modules/robust/robustify.m @@ -36,9 +36,6 @@ % % See also UNCERTAIN -% Author Johan Löfberg -% $Id: robustify.m,v 1.55 2010-03-10 15:19:05 joloef Exp $ - failure = 0; if nargin < 3 ops = sdpsettings; diff --git a/modules/sos/blockmonomialreduction.m b/modules/sos/blockmonomialreduction.m index c2f539ae..25f271a4 100644 --- a/modules/sos/blockmonomialreduction.m +++ b/modules/sos/blockmonomialreduction.m @@ -1,9 +1,6 @@ function N = blockmonomialreduction(exponent_p,N,options) %BLOCKMONOMIALREDUCTION Internal function to reduce monomials in SOS problem -% Author Johan Löfberg -% $Id: blockmonomialreduction.m,v 1.1 2006-03-30 13:39:36 joloef Exp $ - if options.sos.inconsistent & ~options.sos.csp n_removed = 1; while n_removed>0 diff --git a/modules/sos/congruenceblocks.m b/modules/sos/congruenceblocks.m index fb5d6045..b4a417e0 100644 --- a/modules/sos/congruenceblocks.m +++ b/modules/sos/congruenceblocks.m @@ -21,9 +21,6 @@ % % See also NEWTONREDUCE, NEWTONMONOMS, CONSISTENT -% Author Johan Löfberg -% $Id: congruenceblocks.m,v 1.2 2008-11-11 13:29:20 joloef Exp $ - sdpvarout = 0; if isa(exponent_m,'sdpvar') z = depends(exponent_p); diff --git a/modules/sos/consistent.m b/modules/sos/consistent.m index b082e9ca..48ca8bec 100644 --- a/modules/sos/consistent.m +++ b/modules/sos/consistent.m @@ -21,10 +21,6 @@ % % See also NEWTONREDUCE, NEWTONMONOMS, CONGRUENCEBLOCKS -% Author Johan Löfberg -% $Id: consistent.m,v 1.2 2009-11-24 14:53:54 joloef Exp $ - - % Default high level call with SDPVAR polynomials % Convert to exponent form sdpvarout = 0; diff --git a/modules/sos/genmonoms.m b/modules/sos/genmonoms.m index 09e941b5..0f748f9b 100644 --- a/modules/sos/genmonoms.m +++ b/modules/sos/genmonoms.m @@ -1,10 +1,6 @@ function monom = genmonoms(newton_m,x); %GENMONOMS Internal function used in SOS programs -% Author Johan Löfberg -% $Id: genmonoms.m,v 1.1 2006-03-30 13:56:54 joloef Exp $ - - precalc = []; monom = []; for i = 1:size(newton_m,2) diff --git a/modules/sos/monomialgeneration.m b/modules/sos/monomialgeneration.m index 605c1c95..08e0e937 100644 --- a/modules/sos/monomialgeneration.m +++ b/modules/sos/monomialgeneration.m @@ -1,9 +1,6 @@ function exponent_m = monomialgeneration(exponent_p,csclasses) %MONOMIALGENERATION Internal function to create candidate monomials in SOS programs -% Author Johan Löfberg -% $Id: monomialgeneration.m,v 1.1 2006-03-30 13:56:54 joloef Exp $ - exponent_m = []; for i = 1:length(csclasses) if isempty(exponent_p) diff --git a/modules/sos/monomialproducts.m b/modules/sos/monomialproducts.m index 3f381a60..e6ea71ad 100644 --- a/modules/sos/monomialproducts.m +++ b/modules/sos/monomialproducts.m @@ -1,9 +1,6 @@ function [newton_m2,N_unique,newton_m2_unique] = monomialproducts(N,n); %MONOMIALPRODUCTS Internal function used for monomial reduction -% Author Johan Löfberg -% $Id: monomialproducts.m,v 1.1 2006-03-30 13:56:54 joloef Exp $ - % Exponents in squared monomials N_unique = []; diff --git a/modules/sos/monomialreduction.m b/modules/sos/monomialreduction.m index b0237b2b..759e5bb4 100644 --- a/modules/sos/monomialreduction.m +++ b/modules/sos/monomialreduction.m @@ -1,10 +1,6 @@ function exponent_m = monomialreduction(exponent_m,exponent_p,options,csclasses,LPmodel) %MONOMIALREDUCTION Internal function for monomial reduction in SOS programs -% Author Johan Löfberg -% $Id: monomialreduction.m,v 1.2 2006-09-26 14:28:43 joloef Exp $ - - % ********************************************** % TRIVIAL REDUCTIONS (stupid initial generation) % ********************************************** diff --git a/modules/sos/newtonmonoms.m b/modules/sos/newtonmonoms.m index cabfa4cf..3d926886 100644 --- a/modules/sos/newtonmonoms.m +++ b/modules/sos/newtonmonoms.m @@ -16,9 +16,6 @@ % % See also NEWTONREDUCE, CONSISTENT, CONGRUENCEBLOCKS -% Author Johan Löfberg -% $Id: newtonmonoms.m,v 1.1 2006-03-30 13:27:20 joloef Exp $ - if isa(p,'double') v = 1; else diff --git a/modules/sos/newtonpolytope.m b/modules/sos/newtonpolytope.m index 6adfa1a6..7500ccbc 100644 --- a/modules/sos/newtonpolytope.m +++ b/modules/sos/newtonpolytope.m @@ -1,10 +1,6 @@ function keep = newtonpolytope(exponent_m,exponent_p) %NEWTONPOLYTOPE Internal function to remove monimials in SOS programs using Newton polytope -% Author Johan Löfberg -% $Id: newtonpolytope.m,v 1.1 2006-03-30 13:27:20 joloef Exp $ - - % WARNING : THIS CODE SUCKS AND IS ONLY USED AS A BACK UP PLAN % IF EVERYTHING ELSE FAILS (CRASHING LP SOLVERS ETC) diff --git a/solvers/call_cplexibm_qcmiqp.m b/solvers/call_cplexibm_qcmiqp.m index bb89a247..51fe31c2 100644 --- a/solvers/call_cplexibm_qcmiqp.m +++ b/solvers/call_cplexibm_qcmiqp.m @@ -1,7 +1,5 @@ function output = call_cplexibm_qcmiqp(interfacedata) -% Author Johan Löfberg - % This is a gateway to all CPLEX interfaces % Call LP/QP solver if sufficient % Bug in 12.6 regarding display options. Hence, we turn it on and then run diff --git a/solvers/callbintprog.m b/solvers/callbintprog.m index 7de01d31..1749f24d 100644 --- a/solvers/callbintprog.m +++ b/solvers/callbintprog.m @@ -1,4 +1,4 @@ -function output = calllinprog(interfacedata) +function output = callbintprog(interfacedata) % Standard input interface options = interfacedata.options; diff --git a/solvers/calldsdp5.m b/solvers/calldsdp5.m index deb30ad1..35cdd6c6 100644 --- a/solvers/calldsdp5.m +++ b/solvers/calldsdp5.m @@ -1,4 +1,4 @@ -function output = calldsdp(interfacedata) +function output = calldsdp5(interfacedata) % Retrieve needed data options = interfacedata.options; diff --git a/solvers/callglpkcc.m b/solvers/callglpkcc.m index 1c69b517..2a2c4de5 100644 --- a/solvers/callglpkcc.m +++ b/solvers/callglpkcc.m @@ -1,4 +1,4 @@ -function output = callglpk(interfacedata) +function output = callglpkcc(interfacedata) % Retrieve needed data options = interfacedata.options; diff --git a/solvers/callgurobimex.m b/solvers/callgurobimex.m index 90aac4b1..5c742c8a 100644 --- a/solvers/callgurobimex.m +++ b/solvers/callgurobimex.m @@ -1,4 +1,4 @@ -function output = callgurobi(interfacedata) +function output = callgurobimex(interfacedata) % Retrieve needed data options = interfacedata.options; diff --git a/solvers/callipoptgp.m b/solvers/callipoptgp.m index c7b4b1a9..9a58dfd6 100644 --- a/solvers/callipoptgp.m +++ b/solvers/callipoptgp.m @@ -1,4 +1,4 @@ -function output = callfmincongp(interfacedata) +function output = callipoptgp(interfacedata) % Retrieve needed data options = interfacedata.options; diff --git a/solvers/callmaxdet.m b/solvers/callmaxdet.m index f9635787..b92b36b3 100644 --- a/solvers/callmaxdet.m +++ b/solvers/callmaxdet.m @@ -1,4 +1,4 @@ -function output = callmaxdet(interfacedata); +function output = callmaxdet(interfacedata) [F_struc,F_blksz,G_struc,G_blksz] = sedumi2maxdet(interfacedata.F_struc,interfacedata.K); @@ -79,9 +79,6 @@ function [x0,z0,w0,problem,infostr,solveroutput] = callmaxdetphase1(F_struc,F_blksz, G_struc,G_blksz, c, options); -% Author Johan Löfberg -% $Id: callmaxdet.m,v 1.6 2006-12-18 14:42:28 joloef Exp $ - try if options.verbose==0 evalc('[x0,z0,w0,ul] = phase1(full(F_struc),F_blksz,full(G_struc), G_blksz,options.maxdet.gam,options.maxdet.AbsTol,options.maxdet.RelTol,options.maxdet.NTiters);'); diff --git a/solvers/callmpcvx.m b/solvers/callmpcvx.m index a8578c7e..ccb734ac 100644 --- a/solvers/callmpcvx.m +++ b/solvers/callmpcvx.m @@ -1,4 +1,4 @@ -function output = mpcvx(p) +function output = callmpcvx(p) %BMIBNB Branch-and-bound scheme for bilinear programs % % BMIBNB is never called by the user directly, but is called by @@ -26,9 +26,6 @@ % bmibnb.maxiter - Maximum number of solved nodes [int (100)] % bmibnb.maxtime - Maximum CPU time (sec.) [int (3600)] -% Author Johan Löfberg -% $Id: callmpcvx.m,v 1.2 2005-05-07 13:53:20 joloef Exp $ - % ******************************** % INITIALIZE DIAGNOSTICS IN YALMIP % ******************************** diff --git a/solvers/callmplcp.m b/solvers/callmplcp.m index 03a91a7d..4c4b0f5a 100644 --- a/solvers/callmplcp.m +++ b/solvers/callmplcp.m @@ -1,4 +1,4 @@ -function output = callmpt(interfacedata) +function output = callmplcp(interfacedata) % Speeds up solving LPs in mpmilp global mptOptions diff --git a/solvers/callopticsdp.m b/solvers/callopticsdp.m index d93bfcbd..d271f23a 100644 --- a/solvers/callopticsdp.m +++ b/solvers/callopticsdp.m @@ -1,4 +1,4 @@ -function output = calloptidsdp(interfacedata) +function output = callopticsdp(interfacedata) % Retrieve needed data options = interfacedata.options; diff --git a/solvers/callpenbmi.m b/solvers/callpenbmi.m index e2d01684..69c37195 100644 --- a/solvers/callpenbmi.m +++ b/solvers/callpenbmi.m @@ -1,4 +1,4 @@ -function output = callpenbmi(interfacedata); +function output = callpenbmi(interfacedata) % Retrieve needed data options = interfacedata.options; diff --git a/solvers/callpennlp.m b/solvers/callpennlp.m index 0c726fff..27c78a9e 100644 --- a/solvers/callpennlp.m +++ b/solvers/callpennlp.m @@ -1,4 +1,4 @@ -function output = callquadprog(interfacedata) +function output = callpennlp(interfacedata) % Retrieve needed data options = interfacedata.options; diff --git a/solvers/yalmip2cplex.m b/solvers/yalmip2cplex.m index cdd5aefa..6ec3f6b8 100644 --- a/solvers/yalmip2cplex.m +++ b/solvers/yalmip2cplex.m @@ -1,7 +1,5 @@ function [model,nonlinearremain] = yalmip2cplex(interfacedata) -% Author Johan Löfberg - % Retrieve needed data options = interfacedata.options; F_struc = interfacedata.F_struc; diff --git a/solvers/yalmip2opticsdp.m b/solvers/yalmip2opticsdp.m index 9fc08884..c92179e7 100644 --- a/solvers/yalmip2opticsdp.m +++ b/solvers/yalmip2opticsdp.m @@ -1,4 +1,4 @@ -function model = sedumi2opticsdp(interfacedata) +function model = yalmip2opticsdp(interfacedata) % Retrieve needed data options = interfacedata.options; diff --git a/solvers/yalmip2optidsdp.m b/solvers/yalmip2optidsdp.m index 86973057..bf57bf13 100644 --- a/solvers/yalmip2optidsdp.m +++ b/solvers/yalmip2optidsdp.m @@ -1,4 +1,4 @@ -function model = sedumi2optidsdp(interfacedata) +function model = yalmip2optidsdp(interfacedata) % Retrieve needed data options = interfacedata.options;