# HG changeset patch # User Rik # Date 1341864109 25200 # Node ID 5ae9f0f77635eead51579eb75926ebe9a35bc33b # Parent 72b8b39e12be0fc67a5ae46cec21d4734bba1e3d maint: Use Octave coding conventions for coddling parenthis is DLD-FUNCTIONS directory * __fltk_uigetfile__.cc, __glpk__.cc, __init_fltk__.cc, __magick_read__.cc, besselj.cc, bsxfun.cc, ccolamd.cc, cellfun.cc, chol.cc, colamd.cc, daspk.cc, dasrt.cc, dassl.cc, dmperm.cc, fft.cc, filter.cc, find.cc, gcd.cc, kron.cc, lsode.cc, lu.cc, luinc.cc, quad.cc, quadcc.cc, rand.cc, regexp.cc, schur.cc, str2double.cc, symbfact.cc, symrcm.cc, tril.cc, urlwrite.cc: Use Octave coding conventions for coddling parenthis is DLD-FUNCTIONS directory. diff -r 72b8b39e12be -r 5ae9f0f77635 src/DLD-FUNCTIONS/__fltk_uigetfile__.cc --- a/src/DLD-FUNCTIONS/__fltk_uigetfile__.cc Mon Jul 09 10:34:43 2012 -0700 +++ b/src/DLD-FUNCTIONS/__fltk_uigetfile__.cc Mon Jul 09 13:01:49 2012 -0700 @@ -109,7 +109,7 @@ } else { - Cell file_cell = Cell(file_count, 1); + Cell file_cell = Cell (file_count, 1); for (octave_idx_type n = 1; n <= file_count; n++) { fname = fc.value (n); diff -r 72b8b39e12be -r 5ae9f0f77635 src/DLD-FUNCTIONS/__glpk__.cc --- a/src/DLD-FUNCTIONS/__glpk__.cc Mon Jul 09 10:34:43 2012 -0700 +++ b/src/DLD-FUNCTIONS/__glpk__.cc Mon Jul 09 13:01:49 2012 -0700 @@ -282,7 +282,7 @@ } //-- scale the problem data (if required) - //-- if (scale && (!presol || method == 1)) lpx_scale_prob(lp); + //-- if (scale && (!presol || method == 1)) lpx_scale_prob (lp); //-- LPX_K_SCALE=IParam[1] LPX_K_PRESOL=IParam[16] if (lpxIntParam[1] && (! lpxIntParam[16] || lpsolver != 1)) lpx_scale_prob (lp); @@ -291,7 +291,7 @@ if (lpsolver == 1 && ! lpxIntParam[16]) lpx_adv_basis (lp); - for(int i = 0; i < NIntP; i++) + for (int i = 0; i < NIntP; i++) lpx_set_int_parm (lp, IParam[i], lpxIntParam[i]); for (int i = 0; i < NRealP; i++) @@ -313,12 +313,12 @@ errnum = lpx_integer (lp); } else - errnum = lpx_simplex(lp); + errnum = lpx_simplex (lp); } break; case 'T': - errnum = lpx_interior(lp); + errnum = lpx_interior (lp); break; default: @@ -531,10 +531,10 @@ } for (octave_idx_type j = 0; j < Anc; j++) - for (octave_idx_type i = A.cidx(j); i < A.cidx(j+1); i++) + for (octave_idx_type i = A.cidx (j); i < A.cidx (j+1); i++) { nz++; - rn(nz) = A.ridx(i) + 1; + rn(nz) = A.ridx (i) + 1; cn(nz) = j + 1; a(nz) = A.data(i); } diff -r 72b8b39e12be -r 5ae9f0f77635 src/DLD-FUNCTIONS/__init_fltk__.cc --- a/src/DLD-FUNCTIONS/__init_fltk__.cc Mon Jul 09 10:34:43 2012 -0700 +++ b/src/DLD-FUNCTIONS/__init_fltk__.cc Mon Jul 09 13:01:49 2012 -0700 @@ -257,7 +257,7 @@ // Parameter controlling the GUI mode. static enum { pan_zoom, rotate_zoom, none } gui_mode; -void script_cb(Fl_Widget*, void* data) +void script_cb (Fl_Widget*, void* data) { static_cast (data)->execute_callback (); } @@ -269,7 +269,7 @@ fltk_uimenu (int xx, int yy, int ww, int hh) { menubar = new - Fl_Menu_Bar(xx, yy, ww, hh); + Fl_Menu_Bar (xx, yy, ww, hh); } int items_to_show (void) @@ -685,7 +685,7 @@ uimenu->hide (); bottom = new Fl_Box (0, hh - status_h, ww, status_h); - bottom->box(FL_FLAT_BOX); + bottom->box (FL_FLAT_BOX); ndim = calc_dimensions (gh_manager::get_object (fp.get___myhandle__ ())); @@ -1924,8 +1924,8 @@ if (id == uimenu::properties::ID_LABEL) uimenu_set_fltk_label (go); - graphics_object fig = go.get_ancestor("figure"); - figure_manager::uimenu_update(fig.get_handle (), go.get_handle (), id); + graphics_object fig = go.get_ancestor ("figure"); + figure_manager::uimenu_update (fig.get_handle (), go.get_handle (), id); } } diff -r 72b8b39e12be -r 5ae9f0f77635 src/DLD-FUNCTIONS/__magick_read__.cc --- a/src/DLD-FUNCTIONS/__magick_read__.cc Mon Jul 09 10:34:43 2012 -0700 +++ b/src/DLD-FUNCTIONS/__magick_read__.cc Mon Jul 09 13:01:49 2012 -0700 @@ -403,9 +403,9 @@ DEFUN_DLD (__magick_read__, args, nargout, "-*- texinfo -*-\n\ -@deftypefn {Function File} {@var{m} =} __magick_read__(@var{fname}, @var{index})\n\ -@deftypefnx {Function File} {[@var{m}, @var{colormap}] =} __magick_read__(@var{fname}, @var{index})\n\ -@deftypefnx {Function File} {[@var{m}, @var{colormap}, @var{alpha}] =} __magick_read__(@var{fname}, @var{index})\n\ +@deftypefn {Function File} {@var{m} =} __magick_read__ (@var{fname}, @var{index})\n\ +@deftypefnx {Function File} {[@var{m}, @var{colormap}] =} __magick_read__ (@var{fname}, @var{index})\n\ +@deftypefnx {Function File} {[@var{m}, @var{colormap}, @var{alpha}] =} __magick_read__ (@var{fname}, @var{index})\n\ Read images with ImageMagick++. In general you should not be using this\n\ function. Instead use @code{imread}.\n\ @seealso{imread}\n\ @@ -604,7 +604,7 @@ for (unsigned int ii = 0; ii < nframes; ii++) { - Magick::Image im(Magick::Geometry (columns, rows), "black"); + Magick::Image im (Magick::Geometry (columns, rows), "black"); im.classType (Magick::DirectClass); im.depth (1); @@ -871,8 +871,8 @@ DEFUN_DLD (__magick_write__, args, , "-*- texinfo -*-\n\ -@deftypefn {Function File} {} __magick_write__(@var{fname}, @var{fmt}, @var{img})\n\ -@deftypefnx {Function File} {} __magick_write__(@var{fname}, @var{fmt}, @var{img}, @var{map})\n\ +@deftypefn {Function File} {} __magick_write__ (@var{fname}, @var{fmt}, @var{img})\n\ +@deftypefnx {Function File} {} __magick_write__ (@var{fname}, @var{fmt}, @var{img}, @var{map})\n\ Write images with ImageMagick++. In general you should not be using this\n\ function. Instead use @code{imwrite}.\n\ @seealso{imread}\n\ @@ -1007,7 +1007,7 @@ DEFUN_DLD (__magick_finfo__, args, , "-*- texinfo -*-\n\ -@deftypefn {Loadable Function} {} __magick_finfo__(@var{fname})\n\ +@deftypefn {Loadable Function} {} __magick_finfo__ (@var{fname})\n\ Read image information with GraphicsMagick++. In general you should\n\ not be using this function. Instead use @code{imfinfo}.\n\ @seealso{imfinfo, imread}\n\ diff -r 72b8b39e12be -r 5ae9f0f77635 src/DLD-FUNCTIONS/besselj.cc --- a/src/DLD-FUNCTIONS/besselj.cc Mon Jul 09 10:34:43 2012 -0700 +++ b/src/DLD-FUNCTIONS/besselj.cc Mon Jul 09 13:01:49 2012 -0700 @@ -388,21 +388,21 @@ @table @code\n\ @item besselj\n\ Bessel functions of the first kind. If the argument @var{opt} is supplied,\n\ -the result is multiplied by @code{exp(-abs(imag(@var{x})))}.\n\ +the result is multiplied by @code{exp (-abs (imag (@var{x})))}.\n\ \n\ @item bessely\n\ Bessel functions of the second kind. If the argument @var{opt} is supplied,\n\ -the result is multiplied by @code{exp(-abs(imag(@var{x})))}.\n\ +the result is multiplied by @code{exp (-abs (imag (@var{x})))}.\n\ \n\ @item besseli\n\ \n\ Modified Bessel functions of the first kind. If the argument @var{opt} is\n\ -supplied, the result is multiplied by @code{exp(-abs(real(@var{x})))}.\n\ +supplied, the result is multiplied by @code{exp (-abs (real (@var{x})))}.\n\ \n\ @item besselk\n\ \n\ Modified Bessel functions of the second kind. If the argument @var{opt} is\n\ -supplied, the result is multiplied by @code{exp(@var{x})}.\n\ +supplied, the result is multiplied by @code{exp (@var{x})}.\n\ \n\ @item besselh\n\ Compute Hankel functions of the first (@var{k} = 1) or second (@var{k}\n\ @@ -533,8 +533,8 @@ --- -------- ---------------------------------------\n\ 0 Ai (Z) exp ((2/3) * Z * sqrt (Z))\n\ 1 dAi(Z)/dZ exp ((2/3) * Z * sqrt (Z))\n\ - 2 Bi (Z) exp (-abs (real ((2/3) * Z *sqrt (Z))))\n\ - 3 dBi(Z)/dZ exp (-abs (real ((2/3) * Z *sqrt (Z))))\n\ + 2 Bi (Z) exp (-abs (real ((2/3) * Z * sqrt (Z))))\n\ + 3 dBi(Z)/dZ exp (-abs (real ((2/3) * Z * sqrt (Z))))\n\ @end group\n\ @end example\n\ \n\ @@ -1073,8 +1073,8 @@ %! [ 0.0897803119 0.0875062222 0.081029690 0.2785448768 0.2854254970 0.30708743 ]]; %! %! tbl = [besseli(n,z1,1), besselk(n,z1,1)]; -%! tbl(:,3) = tbl(:,3) .* (exp(z1).*z1.^(-2)); -%! tbl(:,6) = tbl(:,6) .* (exp(-z1).*z1.^(2)); +%! tbl(:,3) = tbl(:,3) .* (exp (z1) .* z1.^(-2)); +%! tbl(:,6) = tbl(:,6) .* (exp (-z1) .* z1.^(2)); %! tbl = [tbl;[besseli(n,z2,1),besselk(n,z2,1)]]; %! %! assert (tbl, rtbl, -2e-8); @@ -1111,7 +1111,7 @@ %! I = besseli (n,z,1); %! K = besselk (n,z,1); %! -%! assert (abs (I(1,:)), zeros (1, columns(I))); +%! assert (abs (I(1,:)), zeros (1, columns (I))); %! assert (I(2:end,:), It(2:end,:), -5e-5); %! assert (Kt(1,:), K(1,:)); %! assert (K(2:end,:), Kt(2:end,:), -5e-5); @@ -1154,7 +1154,7 @@ %! assert (besselj (n,1), besselj (-n,1), 1e-8); %! assert (-besselj (n+1,1), besselj (-n-1,1), 1e-8); -besseli(n,z) = besseli(-n,z); +besseli (n,z) = besseli (-n,z); %!test %! n = (0:2:20); @@ -1179,22 +1179,22 @@ %! [ -4.6218e-02 -1.3123e-01 -6.2736e-03 ]; %! [ 8.3907e-02 6.2793e-02 -6.5069e-02 ]]; %! -%! j = sqrt((pi/2)./z).*besselj(n+1/2,z); -%! y = sqrt((pi/2)./z).*bessely(n+1/2,z); -%! assert(jt, j, -5e-5); -%! assert(yt, y, -5e-5); +%! j = sqrt ((pi/2)./z) .* besselj (n+1/2,z); +%! y = sqrt ((pi/2)./z) .* bessely (n+1/2,z); +%! assert (jt, j, -5e-5); +%! assert (yt, y, -5e-5); Table 10.2 - j and y for orders 3-8. Compare against excerpts of Table 10.2, Abramowitzh and Stegun. Important note: In A&S, y_4(0.1) = -1.0507e+7, but Octave returns - y_4(0.1) = -1.0508e+07 (-10507503.75). If I compute the same term using + y_4(0.1) = -1.0508e+07 (-10507503.75). If I compute the same term using a series, the difference is in the eighth significant digit so I left the Octave results in place. %!test %! n = (3:8); -%! z = (0:2.5:10).'; z(1)=0.1; +%! z = (0:2.5:10).'; z(1) = 0.1; %! %! jt = [[ 9.5185e-06 1.0577e-07 9.6163e-10 7.3975e-12 4.9319e-14 2.9012e-16]; %! [ 1.0392e-01 3.0911e-02 7.3576e-03 1.4630e-03 2.5009e-04 3.7516e-05]; diff -r 72b8b39e12be -r 5ae9f0f77635 src/DLD-FUNCTIONS/bsxfun.cc --- a/src/DLD-FUNCTIONS/bsxfun.cc Mon Jul 09 10:34:43 2012 -0700 +++ b/src/DLD-FUNCTIONS/bsxfun.cc Mon Jul 09 13:01:49 2012 -0700 @@ -233,9 +233,9 @@ for (octave_idx_type j = 1; j < nd; j++) { if (dva (j) == 1) - idx (j) = octave_value (1); + idx(j) = octave_value (1); else - idx (j) = octave_value ((i % dvc(j)) + 1); + idx(j) = octave_value ((i % dvc(j)) + 1); i = i / dvc (j); } @@ -785,8 +785,8 @@ %! y = rand (3,1) * 10-5; %! %! for i=1:length (funs) -%! for j = 1:length(float_types) -%! for k = 1:length(int_types) +%! for j = 1:length (float_types) +%! for k = 1:length (int_types) %! %! fun = funs{i}; %! f_type = float_types{j}; diff -r 72b8b39e12be -r 5ae9f0f77635 src/DLD-FUNCTIONS/ccolamd.cc --- a/src/DLD-FUNCTIONS/ccolamd.cc Mon Jul 09 10:34:43 2012 -0700 +++ b/src/DLD-FUNCTIONS/ccolamd.cc Mon Jul 09 13:01:49 2012 -0700 @@ -103,7 +103,7 @@ range 1 to\n\ n). In the output permutation @var{p}, all columns in set 1 appear\n\ first, followed by all columns in set 2, and so on. @code{@var{cmember} =\n\ -ones(1,n)} if not present or empty.\n\ +ones (1,n)} if not present or empty.\n\ @code{ccolamd (@var{S}, [], 1 : n)} returns @code{1 : n}\n\ \n\ @code{@var{p} = ccolamd (@var{S})} is about the same as\n\ @@ -181,14 +181,14 @@ << CCOLAMD_SUB_VERSION << ", " << CCOLAMD_DATE << ":\nknobs(1): " << User_knobs (0) << ", order for "; if ( knobs [CCOLAMD_LU] != 0) - octave_stdout << "lu(A)\n"; + octave_stdout << "lu (A)\n"; else - octave_stdout << "chol(A'*A)\n"; + octave_stdout << "chol (A'*A)\n"; if (knobs [CCOLAMD_DENSE_ROW] >= 0) octave_stdout << "knobs(2): " << User_knobs (1) - << ", rows with > max(16," - << knobs [CCOLAMD_DENSE_ROW] << "*sqrt(size(A,2)))" + << ", rows with > max (16," + << knobs [CCOLAMD_DENSE_ROW] << "*sqrt (size(A,2)))" << " entries removed\n"; else octave_stdout << "knobs(2): " << User_knobs (1) @@ -196,8 +196,8 @@ if (knobs [CCOLAMD_DENSE_COL] >= 0) octave_stdout << "knobs(3): " << User_knobs (2) - << ", cols with > max(16," - << knobs [CCOLAMD_DENSE_COL] << "*sqrt(size(A)))" + << ", cols with > max (16," + << knobs [CCOLAMD_DENSE_COL] << "*sqrt (size(A)))" << " entries removed\n"; else octave_stdout << "knobs(3): " << User_knobs (2) @@ -302,7 +302,7 @@ // return the permutation vector NDArray out_perm (dim_vector (1, n_col)); for (octave_idx_type i = 0; i < n_col; i++) - out_perm(i) = p [i] + 1; + out_perm(i) = p[i] + 1; retval(0) = out_perm; @@ -372,11 +372,11 @@ on the ordering. If @code{@var{cmember}(j) = @var{S}}, then row/column j is\n\ in constraint set @var{c} (@var{c} must be in the range 1 to n). In the\n\ output permutation @var{p}, rows/columns in set 1 appear first, followed\n\ -by all rows/columns in set 2, and so on. @code{@var{cmember} = ones(1,n)}\n\ -if not present or empty. @code{csymamd(@var{S},[],1:n)} returns @code{1:n}.\n\ +by all rows/columns in set 2, and so on. @code{@var{cmember} = ones (1,n)}\n\ +if not present or empty. @code{csymamd (@var{S},[],1:n)} returns @code{1:n}.\n\ \n\ -@code{@var{p} = csymamd(@var{S})} is about the same as @code{@var{p} =\n\ -symamd(@var{S})}. @var{knobs} and its default values differ.\n\ +@code{@var{p} = csymamd (@var{S})} is about the same as @code{@var{p} =\n\ +symamd (@var{S})}. @var{knobs} and its default values differ.\n\ \n\ @code{@var{stats}(4:7)} provide information if CCOLAMD was able to\n\ continue. The matrix is OK if @code{@var{stats}(4)} is zero, or 1 if\n\ @@ -433,8 +433,8 @@ if (knobs [CCOLAMD_DENSE_ROW] >= 0) octave_stdout << "knobs(1): " << User_knobs (0) - << ", rows/cols with > max(16," - << knobs [CCOLAMD_DENSE_ROW] << "*sqrt(size(A,2)))" + << ", rows/cols with > max (16," + << knobs [CCOLAMD_DENSE_ROW] << "*sqrt (size(A,2)))" << " entries removed\n"; else octave_stdout << "knobs(1): " << User_knobs (0) @@ -534,7 +534,7 @@ // return the permutation vector NDArray out_perm (dim_vector (1, n_col)); for (octave_idx_type i = 0; i < n_col; i++) - out_perm(i) = perm [i] + 1; + out_perm(i) = perm[i] + 1; retval(0) = out_perm; diff -r 72b8b39e12be -r 5ae9f0f77635 src/DLD-FUNCTIONS/cellfun.cc --- a/src/DLD-FUNCTIONS/cellfun.cc Mon Jul 09 10:34:43 2012 -0700 +++ b/src/DLD-FUNCTIONS/cellfun.cc Mon Jul 09 13:01:49 2012 -0700 @@ -116,42 +116,42 @@ { boolNDArray result (f_args.dims ()); for (octave_idx_type count = 0; count < k; count++) - result(count) = f_args.elem(count).is_empty (); + result(count) = f_args.elem (count).is_empty (); retval(0) = result; } else if (name == "islogical") { boolNDArray result (f_args.dims ()); for (octave_idx_type count= 0; count < k; count++) - result(count) = f_args.elem(count).is_bool_type (); + result(count) = f_args.elem (count).is_bool_type (); retval(0) = result; } else if (name == "isreal") { boolNDArray result (f_args.dims ()); for (octave_idx_type count= 0; count < k; count++) - result(count) = f_args.elem(count).is_real_type (); + result(count) = f_args.elem (count).is_real_type (); retval(0) = result; } else if (name == "length") { NDArray result (f_args.dims ()); for (octave_idx_type count= 0; count < k; count++) - result(count) = static_cast (f_args.elem(count).length ()); + result(count) = static_cast (f_args.elem (count).length ()); retval(0) = result; } else if (name == "ndims") { NDArray result (f_args.dims ()); for (octave_idx_type count = 0; count < k; count++) - result(count) = static_cast (f_args.elem(count).ndims ()); + result(count) = static_cast (f_args.elem (count).ndims ()); retval(0) = result; } else if (name == "prodofsize" || name == "numel") { NDArray result (f_args.dims ()); for (octave_idx_type count = 0; count < k; count++) - result(count) = static_cast (f_args.elem(count).numel ()); + result(count) = static_cast (f_args.elem (count).numel ()); retval(0) = result; } else if (name == "size") @@ -168,7 +168,7 @@ NDArray result (f_args.dims ()); for (octave_idx_type count = 0; count < k; count++) { - dim_vector dv = f_args.elem(count).dims (); + dim_vector dv = f_args.elem (count).dims (); if (d < dv.length ()) result(count) = static_cast (dv(d)); else @@ -187,7 +187,7 @@ std::string class_name = args(2).string_value (); boolNDArray result (f_args.dims ()); for (octave_idx_type count = 0; count < k; count++) - result(count) = (f_args.elem(count).class_name () == class_name); + result(count) = (f_args.elem (count).class_name () == class_name); retval(0) = result; } @@ -317,7 +317,7 @@ a = x;\n\ b = x*x;\n\ endfunction\n\ -[aa, bb] = cellfun(@@twoouts, @{1, 2, 3@})\n\ +[aa, bb] = cellfun (@@twoouts, @{1, 2, 3@})\n\ @result{}\n\ aa =\n\ 1 2 3\n\ @@ -375,7 +375,7 @@ @example\n\ @group\n\ a = @{@dots{}@}\n\ -v = cellfun (@@(x) det(x), a); # compute determinants\n\ +v = cellfun (@@(x) det (x), a); # compute determinants\n\ v = cellfun (@@det, a); # faster\n\ @end group\n\ @end example\n\ @@ -767,7 +767,7 @@ %! A = cellfun (@islogical, {true, 0.1, false, i*2}); %! assert (A, [true, false, true, false]); %!test -%! A = cellfun (@(x) islogical(x), {true, 0.1, false, i*2}); +%! A = cellfun (@(x) islogical (x), {true, 0.1, false, i*2}); %! assert (A, [true, false, true, false]); %% First input argument can be the special string "isreal", @@ -864,7 +864,7 @@ %! assert (isequal (B, {true, true; [], true})); %! assert (isequal (C, {10, 11; [], 12})); %!test -%! A = cellfun (@(x,y) cell2str(x,y), {1.1, 4}, {3.1, 6}, \ +%! A = cellfun (@(x,y) cell2str (x,y), {1.1, 4}, {3.1, 6}, \ %! "ErrorHandler", @__cellfunerror); %! B = isfield (A(1), "message") && isfield (A(1), "index"); %! assert ([(isfield (A(1), "identifier")), (isfield (A(2), "identifier"))], [true, true]); @@ -873,7 +873,7 @@ %! assert ([(isempty (A(1).message)), (isempty (A(2).message))], [false, false]); %! assert ([A(1).index, A(2).index], [1, 2]); %!test %% Overwriting setting of "UniformOutput" true -%! A = cellfun (@(x,y) cell2str(x,y), {1.1, 4}, {3.1, 6}, \ +%! A = cellfun (@(x,y) cell2str (x,y), {1.1, 4}, {3.1, 6}, \ %! "UniformOutput", true, "ErrorHandler", @__cellfunerror); %! B = isfield (A(1), "message") && isfield (A(1), "index"); %! assert ([(isfield (A(1), "identifier")), (isfield (A(2), "identifier"))], [true, true]); @@ -892,7 +892,7 @@ %! A = cellfun (@(x,y) x:y, {"a", "d"}, {"c", "f"}, "UniformOutput", false); %! assert (A, {"abc", "def"}); %!test -%! A = cellfun (@(x,y) cell2str(x,y), {"a", "d"}, {"c", "f"}, \ +%! A = cellfun (@(x,y) cell2str (x,y), {"a", "d"}, {"c", "f"}, \ %! "ErrorHandler", @__cellfunerror); %! assert ([(isfield (A(1), "identifier")), (isfield (A(2), "identifier"))], [true, true]); %! assert ([(isfield (A(1), "message")), (isfield (A(2), "message"))], [true, true]); @@ -900,7 +900,7 @@ %! assert ([(isempty (A(1).message)), (isempty (A(2).message))], [false, false]); %! assert ([A(1).index, A(2).index], [1, 2]); %!test %% Overwriting setting of "UniformOutput" true -%! A = cellfun (@(x,y) cell2str(x,y), {"a", "d"}, {"c", "f"}, \ +%! A = cellfun (@(x,y) cell2str (x,y), {"a", "d"}, {"c", "f"}, \ %! "UniformOutput", true, "ErrorHandler", @__cellfunerror); %! assert ([(isfield (A(1), "identifier")), (isfield (A(2), "identifier"))], [true, true]); %! assert ([(isfield (A(1), "message")), (isfield (A(2), "message"))], [true, true]); @@ -926,7 +926,7 @@ %! "UniformOutput", false); %! assert (A, {true, false}); %!test -%! A = cellfun (@(x,y) mat2str(x,y), {{1.1}, {4.2}}, {{3.1}, {2}}, \ +%! A = cellfun (@(x,y) mat2str (x,y), {{1.1}, {4.2}}, {{3.1}, {2}}, \ %! "ErrorHandler", @__cellfunerror); %! assert ([(isfield (A(1), "identifier")), (isfield (A(2), "identifier"))], [true, true]); %! assert ([(isfield (A(1), "message")), (isfield (A(2), "message"))], [true, true]); @@ -934,7 +934,7 @@ %! assert ([(isempty (A(1).message)), (isempty (A(2).message))], [false, false]); %! assert ([A(1).index, A(2).index], [1, 2]); %!test %% Overwriting setting of "UniformOutput" true -%! A = cellfun (@(x,y) mat2str(x,y), {{1.1}, {4.2}}, {{3.1}, {2}}, \ +%! A = cellfun (@(x,y) mat2str (x,y), {{1.1}, {4.2}}, {{3.1}, {2}}, \ %! "UniformOutput", true, "ErrorHandler", @__cellfunerror); %! assert ([(isfield (A(1), "identifier")), (isfield (A(2), "identifier"))], [true, true]); %! assert ([(isfield (A(1), "message")), (isfield (A(2), "message"))], [true, true]); @@ -1489,7 +1489,7 @@ %! A = arrayfun (@isequal, [false, true], [true, true]); %! assert (A, [false, true]); %!test -%! A = arrayfun (@(x,y) isequal(x,y), [false, true], [true, true]); +%! A = arrayfun (@(x,y) isequal (x,y), [false, true], [true, true]); %! assert (A, [false, true]); %% Number of input and output arguments may be greater than one @@ -1561,7 +1561,7 @@ %! assert (isequal (B, {true, true; [], true})); %! assert (isequal (C, {10, 11; [], 12})); %!test -%! A = arrayfun (@(x,y) array2str(x,y), {1.1, 4}, {3.1, 6}, \ +%! A = arrayfun (@(x,y) array2str (x,y), {1.1, 4}, {3.1, 6}, \ %! "ErrorHandler", @__arrayfunerror); %! B = isfield (A(1), "message") && isfield (A(1), "index"); %! assert ([(isfield (A(1), "identifier")), (isfield (A(2), "identifier"))], [true, true]); @@ -1570,7 +1570,7 @@ %! assert ([(isempty (A(1).message)), (isempty (A(2).message))], [false, false]); %! assert ([A(1).index, A(2).index], [1, 2]); %!test %% Overwriting setting of "UniformOutput" true -%! A = arrayfun (@(x,y) array2str(x,y), {1.1, 4}, {3.1, 6}, \ +%! A = arrayfun (@(x,y) array2str (x,y), {1.1, 4}, {3.1, 6}, \ %! "UniformOutput", true, "ErrorHandler", @__arrayfunerror); %! B = isfield (A(1), "message") && isfield (A(1), "index"); %! assert ([(isfield (A(1), "identifier")), (isfield (A(2), "identifier"))], [true, true]); @@ -1590,7 +1590,7 @@ %! A = arrayfun (@(x,y) x:y, ["a", "d"], ["c", "f"], "UniformOutput", false); %! assert (A, {"abc", "def"}); %!test -%! A = arrayfun (@(x,y) cell2str(x,y), ["a", "d"], ["c", "f"], \ +%! A = arrayfun (@(x,y) cell2str (x,y), ["a", "d"], ["c", "f"], \ %! "ErrorHandler", @__arrayfunerror); %! B = isfield (A(1), "identifier") && isfield (A(1), "message") && isfield (A(1), "index"); %! assert (B, true); @@ -1642,7 +1642,7 @@ %! assert ([(isempty (A(1).message)), (isempty (A(2).message))], [false, false]); %! assert ([A(1).index, A(2).index], [1, 2]); %!test -%! A = arrayfun (@(x,y) num2str(x,y), {1.1, 4.2}, {3.1, 2}, \ +%! A = arrayfun (@(x,y) num2str (x,y), {1.1, 4.2}, {3.1, 2}, \ %! "UniformOutput", true, "ErrorHandler", @__arrayfunerror); %! assert ([(isfield (A(1), "identifier")), (isfield (A(2), "identifier"))], [true, true]); %! assert ([(isfield (A(1), "message")), (isfield (A(2), "message"))], [true, true]); @@ -1790,7 +1790,7 @@ idx(0) = double (i+1); - retval.xelem(i) = array.single_subsref ("(", idx); + retval.xelem (i) = array.single_subsref ("(", idx); if (error_state) break; diff -r 72b8b39e12be -r 5ae9f0f77635 src/DLD-FUNCTIONS/chol.cc --- a/src/DLD-FUNCTIONS/chol.cc Mon Jul 09 10:34:43 2012 -0700 +++ b/src/DLD-FUNCTIONS/chol.cc Mon Jul 09 13:01:49 2012 -0700 @@ -372,11 +372,11 @@ /* %!assert (chol ([2, 1; 1, 1]), [sqrt(2), 1/sqrt(2); 0, 1/sqrt(2)], sqrt (eps)) -%!assert (chol (single([2, 1; 1, 1])), single([sqrt(2), 1/sqrt(2); 0, 1/sqrt(2)]), sqrt (eps ("single"))) +%!assert (chol (single ([2, 1; 1, 1])), single ([sqrt(2), 1/sqrt(2); 0, 1/sqrt(2)]), sqrt (eps ("single"))) +%!error chol () %!error chol ([1, 2; 3, 4]) %!error chol ([1, 2; 3, 4; 5, 6]) -%!error chol () %!error chol (1, 2) */ @@ -989,7 +989,7 @@ %! -0.13825 ; %! 0.45266 ]); %! -%! R = chol(single(A)); +%! R = chol (single (A)); %! %! j = 3; p = [1:j-1, j+1:5]; %! R1 = cholinsert (R, j, u2); @@ -1183,7 +1183,7 @@ /* %!test -%! R = chol(A); +%! R = chol (A); %! %! j = 3; p = [1:j-1,j+1:4]; %! R1 = choldelete (R, j); @@ -1210,10 +1210,10 @@ %! assert (norm (R1'*R1 - single (A(p,p)), Inf) < 1e1*eps ("single")); %!test -%! R = chol(single(Ac)); +%! R = chol (single (Ac)); %! %! j = 3; p = [1:j-1,j+1:4]; -%! R1 = choldelete(R,j); +%! R1 = choldelete (R,j); %! %! assert (norm (triu (R1)-R1, Inf), single (0)); %! assert (norm (R1'*R1 - single (Ac(p,p)), Inf) < 1e1*eps ("single")); @@ -1335,8 +1335,8 @@ %! j = 1; i = 3; p = [1:j-1, shift(j:i,+1), i+1:4]; %! R1 = cholshift (R, i, j); %! -%! assert (norm(triu(R1)-R1, Inf), 0); -%! assert (norm(R1'*R1 - A(p,p), Inf) < 1e1*eps); +%! assert (norm (triu (R1) - R1, Inf), 0); +%! assert (norm (R1'*R1 - A(p,p), Inf) < 1e1*eps); %!test %! R = chol (Ac); diff -r 72b8b39e12be -r 5ae9f0f77635 src/DLD-FUNCTIONS/colamd.cc --- a/src/DLD-FUNCTIONS/colamd.cc Mon Jul 09 10:34:43 2012 -0700 +++ b/src/DLD-FUNCTIONS/colamd.cc Mon Jul 09 13:01:49 2012 -0700 @@ -226,7 +226,7 @@ @var{knobs} is an optional one- to three-element input vector. If @var{S} is\n\ m-by-n, then rows with more than @code{max(16,@var{knobs}(1)*sqrt(n))}\n\ entries are ignored. Columns with more than\n\ -@code{max(16,@var{knobs}(2)*sqrt(min(m,n)))} entries are removed prior to\n\ +@code{max (16,@var{knobs}(2)*sqrt(min(m,n)))} entries are removed prior to\n\ ordering, and ordered last in the output permutation @var{p}. Only\n\ completely dense rows or columns are removed if @code{@var{knobs}(1)} and\n\ @code{@var{knobs}(2)} are < 0, respectively. If @code{@var{knobs}(3)} is\n\ @@ -314,8 +314,8 @@ if (knobs [COLAMD_DENSE_ROW] >= 0) octave_stdout << "knobs(1): " << User_knobs (0) - << ", rows with > max(16," - << knobs [COLAMD_DENSE_ROW] << "*sqrt(size(A,2)))" + << ", rows with > max (16," + << knobs [COLAMD_DENSE_ROW] << "*sqrt (size(A,2)))" << " entries removed\n"; else octave_stdout << "knobs(1): " << User_knobs (0) @@ -323,8 +323,8 @@ if (knobs [COLAMD_DENSE_COL] >= 0) octave_stdout << "knobs(2): " << User_knobs (1) - << ", cols with > max(16," - << knobs [COLAMD_DENSE_COL] << "*sqrt(size(A)))" + << ", cols with > max (16," + << knobs [COLAMD_DENSE_COL] << "*sqrt (size(A)))" << " entries removed\n"; else octave_stdout << "knobs(2): " << User_knobs (1) @@ -415,7 +415,7 @@ // return the permutation vector NDArray out_perm (dim_vector (1, n_col)); for (octave_idx_type i = 0; i < n_col; i++) - out_perm(i) = p [colbeg [i]] + 1; + out_perm(i) = p[colbeg [i]] + 1; retval(0) = out_perm; @@ -464,7 +464,7 @@ \n\ @var{knobs} is an optional one- to two-element input vector. If @var{S} is\n\ n-by-n, then rows and columns with more than\n\ -@code{max(16,@var{knobs}(1)*sqrt(n))} entries are removed prior to ordering,\n\ +@code{max (16,@var{knobs}(1)*sqrt(n))} entries are removed prior to ordering,\n\ and ordered last in the output permutation @var{p}. No rows/columns are\n\ removed if @code{@var{knobs}(1) < 0}. If @code{@var{knobs} (2)} is nonzero,\n\ @code{stats} and @var{knobs} are printed. The default is @code{@var{knobs}\n\ @@ -608,7 +608,7 @@ // return the permutation vector NDArray out_perm (dim_vector (1, n_col)); for (octave_idx_type i = 0; i < n_col; i++) - out_perm(i) = perm [post [i]] + 1; + out_perm(i) = perm[post [i]] + 1; retval(0) = out_perm; diff -r 72b8b39e12be -r 5ae9f0f77635 src/DLD-FUNCTIONS/daspk.cc --- a/src/DLD-FUNCTIONS/daspk.cc Mon Jul 09 10:34:43 2012 -0700 +++ b/src/DLD-FUNCTIONS/daspk.cc Mon Jul 09 13:01:49 2012 -0700 @@ -321,7 +321,7 @@ { jac_name = unique_symbol_name ("__daspk_jac__"); jname = "function jac = "; - jname.append(jac_name); + jname.append (jac_name); jname.append (" (x, xdot, t, cj) jac = "); daspk_jac = extract_function (c(1), "daspk", jac_name, jname, "; endfunction"); @@ -377,7 +377,7 @@ { jac_name = unique_symbol_name ("__daspk_jac__"); jname = "function jac = "; - jname.append(jac_name); + jname.append (jac_name); jname.append (" (x, xdot, t, cj) jac = "); daspk_jac = extract_function (tmp(1), "daspk", jac_name, jname, diff -r 72b8b39e12be -r 5ae9f0f77635 src/DLD-FUNCTIONS/dasrt.cc --- a/src/DLD-FUNCTIONS/dasrt.cc Mon Jul 09 10:34:43 2012 -0700 +++ b/src/DLD-FUNCTIONS/dasrt.cc Mon Jul 09 13:01:49 2012 -0700 @@ -409,7 +409,7 @@ { jac_name = unique_symbol_name ("__dasrt_jac__"); jname = "function jac = "; - jname.append(jac_name); + jname.append (jac_name); jname.append (" (x, xdot, t, cj) jac = "); dasrt_j = extract_function (c(1), "dasrt", jac_name, jname, "; endfunction"); @@ -461,7 +461,7 @@ { jac_name = unique_symbol_name ("__dasrt_jac__"); jname = "function jac = "; - jname.append(jac_name); + jname.append (jac_name); jname.append (" (x, xdot, t, cj) jac = "); dasrt_j = extract_function (tmp(1), "dasrt", jac_name, jname, "; endfunction"); diff -r 72b8b39e12be -r 5ae9f0f77635 src/DLD-FUNCTIONS/dassl.cc --- a/src/DLD-FUNCTIONS/dassl.cc Mon Jul 09 10:34:43 2012 -0700 +++ b/src/DLD-FUNCTIONS/dassl.cc Mon Jul 09 13:01:49 2012 -0700 @@ -322,7 +322,7 @@ { jac_name = unique_symbol_name ("__dassl_jac__"); jname = "function jac = "; - jname.append(jac_name); + jname.append (jac_name); jname.append (" (x, xdot, t, cj) jac = "); dassl_jac = extract_function (c(1), "dassl", jac_name, jname, "; endfunction"); @@ -378,7 +378,7 @@ { jac_name = unique_symbol_name ("__dassl_jac__"); jname = "function jac = "; - jname.append(jac_name); + jname.append (jac_name); jname.append (" (x, xdot, t, cj) jac = "); dassl_jac = extract_function (tmp(1), "dassl", jac_name, jname, diff -r 72b8b39e12be -r 5ae9f0f77635 src/DLD-FUNCTIONS/dmperm.cc --- a/src/DLD-FUNCTIONS/dmperm.cc Mon Jul 09 10:34:43 2012 -0700 +++ b/src/DLD-FUNCTIONS/dmperm.cc Mon Jul 09 13:01:49 2012 -0700 @@ -48,7 +48,7 @@ { RowVector ret (n); for (octave_idx_type i = 0; i < n; i++) - ret.xelem(i) = p[i] + 1; + ret.xelem (i) = p[i] + 1; return ret; } diff -r 72b8b39e12be -r 5ae9f0f77635 src/DLD-FUNCTIONS/fft.cc --- a/src/DLD-FUNCTIONS/fft.cc Mon Jul 09 10:34:43 2012 -0700 +++ b/src/DLD-FUNCTIONS/fft.cc Mon Jul 09 13:01:49 2012 -0700 @@ -280,7 +280,7 @@ %! t = 2*pi*(0:1:N-1)/N; %! s = cos (n*t); %! -%! S = zeros (size(t)); +%! S = zeros (size (t)); %! S(n+1) = N/2; %! S(N-n+1) = N/2; %! diff -r 72b8b39e12be -r 5ae9f0f77635 src/DLD-FUNCTIONS/filter.cc --- a/src/DLD-FUNCTIONS/filter.cc Mon Jul 09 10:34:43 2012 -0700 +++ b/src/DLD-FUNCTIONS/filter.cc Mon Jul 09 13:01:49 2012 -0700 @@ -716,9 +716,9 @@ %! y = filter (b, [1], x); %! assert (y, y0); -%!assert (filter (1, ones(10,1)/10, []), []) -%!assert (filter (1, ones(10,1)/10, zeros(0,10)), zeros(0,10)) -%!assert (filter (1, ones(10,1)/10, single (1:5)), repmat (single (10), 1, 5)) +%!assert (filter (1, ones (10,1) / 10, []), []) +%!assert (filter (1, ones (10,1) / 10, zeros (0,10)), zeros (0,10)) +%!assert (filter (1, ones (10,1) / 10, single (1:5)), repmat (single (10), 1, 5)) %% Test using initial conditions %!assert (filter ([1, 1, 1], [1, 1], [1 2], [1, 1]), [2 2]) diff -r 72b8b39e12be -r 5ae9f0f77635 src/DLD-FUNCTIONS/find.cc --- a/src/DLD-FUNCTIONS/find.cc Mon Jul 09 10:34:43 2012 -0700 +++ b/src/DLD-FUNCTIONS/find.cc Mon Jul 09 13:01:49 2012 -0700 @@ -111,9 +111,9 @@ for (octave_idx_type j = 0; j < nc; j++) { OCTAVE_QUIT; - if (v.cidx(j) == 0 && v.cidx(j+1) != 0) + if (v.cidx (j) == 0 && v.cidx (j+1) != 0) start_nc = j; - if (v.cidx(j+1) >= n_to_find) + if (v.cidx (j+1) >= n_to_find) { end_nc = j + 1; break; @@ -125,9 +125,9 @@ for (octave_idx_type j = nc; j > 0; j--) { OCTAVE_QUIT; - if (v.cidx(j) == nz && v.cidx(j-1) != nz) + if (v.cidx (j) == nz && v.cidx (j-1) != nz) end_nc = j; - if (nz - v.cidx(j-1) >= n_to_find) + if (nz - v.cidx (j-1) >= n_to_find) { start_nc = j - 1; break; @@ -135,8 +135,8 @@ } } - count = (n_to_find > v.cidx(end_nc) - v.cidx(start_nc) ? - v.cidx(end_nc) - v.cidx(start_nc) : n_to_find); + count = (n_to_find > v.cidx (end_nc) - v.cidx (start_nc) ? + v.cidx (end_nc) - v.cidx (start_nc) : n_to_find); // If the original argument was a row vector, force a row vector of // the overall indices to be returned. But see below for scalar @@ -168,14 +168,14 @@ // there are elements to be found using the count that we want // to find. for (octave_idx_type j = start_nc, cx = 0; j < end_nc; j++) - for (octave_idx_type i = v.cidx(j); i < v.cidx(j+1); i++ ) + for (octave_idx_type i = v.cidx (j); i < v.cidx (j+1); i++ ) { OCTAVE_QUIT; if (direction < 0 && i < nz - count) continue; - i_idx(cx) = static_cast (v.ridx(i) + 1); + i_idx(cx) = static_cast (v.ridx (i) + 1); j_idx(cx) = static_cast (j + 1); - idx(cx) = j * nr + v.ridx(i) + 1; + idx(cx) = j * nr + v.ridx (i) + 1; val(cx) = v.data(i); cx++; if (cx == count) diff -r 72b8b39e12be -r 5ae9f0f77635 src/DLD-FUNCTIONS/gcd.cc --- a/src/DLD-FUNCTIONS/gcd.cc Mon Jul 09 10:34:43 2012 -0700 +++ b/src/DLD-FUNCTIONS/gcd.cc Mon Jul 09 13:01:49 2012 -0700 @@ -76,8 +76,8 @@ static std::complex simple_gcd (const std::complex& a, const std::complex& b) { - if (! xisinteger (a.real ()) || ! xisinteger(a.imag ()) - || ! xisinteger (b.real ()) || ! xisinteger(b.imag ())) + if (! xisinteger (a.real ()) || ! xisinteger (a.imag ()) + || ! xisinteger (b.real ()) || ! xisinteger (b.imag ())) (*current_liboctave_error_handler) ("gcd: all complex parts must be integers"); @@ -156,8 +156,8 @@ extended_gcd (const std::complex& a, const std::complex& b, std::complex& x, std::complex& y) { - if (! xisinteger (a.real ()) || ! xisinteger(a.imag ()) - || ! xisinteger (b.real ()) || ! xisinteger(b.imag ())) + if (! xisinteger (a.real ()) || ! xisinteger (a.imag ()) + || ! xisinteger (b.real ()) || ! xisinteger (b.imag ())) (*current_liboctave_error_handler) ("gcd: all complex parts must be integers"); diff -r 72b8b39e12be -r 5ae9f0f77635 src/DLD-FUNCTIONS/kron.cc --- a/src/DLD-FUNCTIONS/kron.cc Mon Jul 09 10:34:43 2012 -0700 +++ b/src/DLD-FUNCTIONS/kron.cc Mon Jul 09 13:01:49 2012 -0700 @@ -88,7 +88,7 @@ for (octave_idx_type jb = 0; jb < ncb; jb++) { octave_quit (); - mx_inline_mul (nrb, &c.xelem(ja*nrb, ja*ncb + jb), a.dgelem (ja), b.data () + nrb*jb); + mx_inline_mul (nrb, &c.xelem (ja*nrb, ja*ncb + jb), a.dgelem (ja), b.data () + nrb*jb); } return c; @@ -110,7 +110,7 @@ octave_quit (); for (octave_idx_type Ai = A.cidx (Aj); Ai < A.cidx (Aj+1); Ai++) { - octave_idx_type Ci = A.ridx(Ai) * B.rows (); + octave_idx_type Ci = A.ridx (Ai) * B.rows (); const T v = A.data (Ai); for (octave_idx_type Bi = B.cidx (Bj); Bi < B.cidx (Bj+1); Bi++) diff -r 72b8b39e12be -r 5ae9f0f77635 src/DLD-FUNCTIONS/lsode.cc --- a/src/DLD-FUNCTIONS/lsode.cc Mon Jul 09 10:34:43 2012 -0700 +++ b/src/DLD-FUNCTIONS/lsode.cc Mon Jul 09 13:01:49 2012 -0700 @@ -171,7 +171,7 @@ @example\n\ @group\n\ dx\n\ --- = f(x, t)\n\ +-- = f (x, t)\n\ dt\n\ @end group\n\ @end example\n\ @@ -322,7 +322,7 @@ { jac_name = unique_symbol_name ("__lsode_jac__"); jname = "function jac = "; - jname.append(jac_name); + jname.append (jac_name); jname.append (" (x, t) jac = "); lsode_jac = extract_function (c(1), "lsode", jac_name, jname, "; endfunction"); @@ -378,7 +378,7 @@ { jac_name = unique_symbol_name ("__lsode_jac__"); jname = "function jac = "; - jname.append(jac_name); + jname.append (jac_name); jname.append (" (x, t) jac = "); lsode_jac = extract_function (tmp(1), "lsode", jac_name, jname, diff -r 72b8b39e12be -r 5ae9f0f77635 src/DLD-FUNCTIONS/lu.cc --- a/src/DLD-FUNCTIONS/lu.cc Mon Jul 09 10:34:43 2012 -0700 +++ b/src/DLD-FUNCTIONS/lu.cc Mon Jul 09 13:01:49 2012 -0700 @@ -179,7 +179,7 @@ error ("lu: can not define pivoting threshold THRES for full matrices"); else if (tmp.nelem () == 1) { - thres.resize(1,2); + thres.resize (1,2); thres(0) = tmp(0); thres(1) = tmp(0); } diff -r 72b8b39e12be -r 5ae9f0f77635 src/DLD-FUNCTIONS/luinc.cc --- a/src/DLD-FUNCTIONS/luinc.cc Mon Jul 09 10:34:43 2012 -0700 +++ b/src/DLD-FUNCTIONS/luinc.cc Mon Jul 09 13:01:49 2012 -0700 @@ -154,7 +154,7 @@ if (thresh.nelem () == 1) { - thresh.resize(1,2); + thresh.resize (1,2); thresh(1) = thresh(0); } else if (thresh.nelem () != 2) diff -r 72b8b39e12be -r 5ae9f0f77635 src/DLD-FUNCTIONS/quad.cc --- a/src/DLD-FUNCTIONS/quad.cc Mon Jul 09 10:34:43 2012 -0700 +++ b/src/DLD-FUNCTIONS/quad.cc Mon Jul 09 13:01:49 2012 -0700 @@ -192,7 +192,7 @@ absolute tolerance, and the second element is the desired relative\n\ tolerance. To choose a relative test only, set the absolute\n\ tolerance to zero. To choose an absolute test only, set the relative\n\ -tolerance to zero. Both tolerances default to @code{sqrt(eps)} or\n\ +tolerance to zero. Both tolerances default to @code{sqrt (eps)} or\n\ approximately @math{1.5e^{-8}}.\n\ \n\ The optional argument @var{sing} is a vector of values at which the\n\ diff -r 72b8b39e12be -r 5ae9f0f77635 src/DLD-FUNCTIONS/quadcc.cc --- a/src/DLD-FUNCTIONS/quadcc.cc Mon Jul 09 10:34:43 2012 -0700 +++ b/src/DLD-FUNCTIONS/quadcc.cc Mon Jul 09 13:01:49 2012 -0700 @@ -1493,7 +1493,7 @@ \n\ @var{a} and @var{b} are the lower and upper limits of integration. Either\n\ or both limits may be infinite. @code{quadcc} handles an inifinite limit\n\ -by substituting the variable of integration with @code{x=tan(pi/2*u)}.\n\ +by substituting the variable of integration with @code{x = tan (pi/2*u)}.\n\ \n\ The optional argument @var{tol} defines the relative tolerance used to stop\n\ the integration procedure. The default value is @math{1e^{-6}}.\n\ diff -r 72b8b39e12be -r 5ae9f0f77635 src/DLD-FUNCTIONS/rand.cc --- a/src/DLD-FUNCTIONS/rand.cc Mon Jul 09 10:34:43 2012 -0700 +++ b/src/DLD-FUNCTIONS/rand.cc Mon Jul 09 13:01:49 2012 -0700 @@ -691,7 +691,7 @@ @deftypefnx {Loadable Function} {} randg (\"seed\", \"reset\")\n\ @deftypefnx {Loadable Function} {} randg (@dots{}, \"single\")\n\ @deftypefnx {Loadable Function} {} randg (@dots{}, \"double\")\n\ -Return a matrix with @code{gamma(@var{a},1)} distributed random elements.\n\ +Return a matrix with @code{gamma (@var{a},1)} distributed random elements.\n\ The arguments are handled the same as the arguments for @code{rand},\n\ except for the argument @var{a}.\n\ \n\ diff -r 72b8b39e12be -r 5ae9f0f77635 src/DLD-FUNCTIONS/regexp.cc --- a/src/DLD-FUNCTIONS/regexp.cc Mon Jul 09 10:34:43 2012 -0700 +++ b/src/DLD-FUNCTIONS/regexp.cc Mon Jul 09 13:01:49 2012 -0700 @@ -508,7 +508,7 @@ Cell cellpat = args(1).cell_value (); for (int j = 0; j < nargout; j++) - newretval[j].resize(cellpat.dims ()); + newretval[j].resize (cellpat.dims ()); for (octave_idx_type i = 0; i < cellpat.numel (); i++) { diff -r 72b8b39e12be -r 5ae9f0f77635 src/DLD-FUNCTIONS/schur.cc --- a/src/DLD-FUNCTIONS/schur.cc Mon Jul 09 10:34:43 2012 -0700 +++ b/src/DLD-FUNCTIONS/schur.cc Mon Jul 09 13:01:49 2012 -0700 @@ -286,7 +286,7 @@ %! assert (u' * a * u, s, sqrt (eps ("single"))); %!test -%! fail("schur ([1, 2; 3, 4], 2)", "warning"); +%! fail ("schur ([1, 2; 3, 4], 2)", "warning"); %!error schur () %!error schur ([1, 2, 3; 4, 5, 6]) diff -r 72b8b39e12be -r 5ae9f0f77635 src/DLD-FUNCTIONS/str2double.cc --- a/src/DLD-FUNCTIONS/str2double.cc Mon Jul 09 10:34:43 2012 -0700 +++ b/src/DLD-FUNCTIONS/str2double.cc Mon Jul 09 13:01:49 2012 -0700 @@ -402,5 +402,5 @@ %!assert (str2double ("-i*NaN - Inf"), complex (-Inf, -NaN)) %!assert (str2double ({"abc", "4i"}), [NaN + 0i, 4i]) %!assert (str2double ({2, "4i"}), [NaN + 0i, 4i]) -%!assert (str2double (zeros(3,1,2)), NaN (3,1,2)) +%!assert (str2double (zeros (3,1,2)), NaN (3,1,2)) */ diff -r 72b8b39e12be -r 5ae9f0f77635 src/DLD-FUNCTIONS/symbfact.cc --- a/src/DLD-FUNCTIONS/symbfact.cc Mon Jul 09 10:34:43 2012 -0700 +++ b/src/DLD-FUNCTIONS/symbfact.cc Mon Jul 09 13:01:49 2012 -0700 @@ -223,13 +223,13 @@ if (cm->status < CHOLMOD_OK) { - error("matrix corrupted"); + error ("matrix corrupted"); goto symbfact_error; } if (CHOLMOD_NAME(postorder) (Parent, n, 0, Post, cm) != n) { - error("postorder failed"); + error ("postorder failed"); goto symbfact_error; } @@ -238,7 +238,7 @@ if (cm->status < CHOLMOD_OK) { - error("matrix corrupted"); + error ("matrix corrupted"); goto symbfact_error; } @@ -289,7 +289,7 @@ /* create a copy of the column pointers */ octave_idx_type *W = First; for (octave_idx_type j = 0 ; j < n ; j++) - W [j] = L.xcidx(j); + W[j] = L.xcidx (j); // get workspace for computing one row of L cholmod_sparse *R = cholmod_allocate_sparse (n, 1, n, false, true, diff -r 72b8b39e12be -r 5ae9f0f77635 src/DLD-FUNCTIONS/symrcm.cc --- a/src/DLD-FUNCTIONS/symrcm.cc Mon Jul 09 10:34:43 2012 -0700 +++ b/src/DLD-FUNCTIONS/symrcm.cc Mon Jul 09 13:01:49 2012 -0700 @@ -182,7 +182,7 @@ CMK_Node r = H[0]; H[0] = H[--h]; if (reorg) - H_heapify_min(H, 0, h); + H_heapify_min (H, 0, h); return r; } @@ -601,7 +601,7 @@ w.id = r2; w.deg = D[r2]; w.dist = v.dist+1; - H_insert(S, s, w); + H_insert (S, s, w); visit[r2] = true; } } @@ -613,7 +613,7 @@ w.id = r1; w.deg = D[r1]; w.dist = v.dist+1; - H_insert(S, s, w); + H_insert (S, s, w); visit[r1] = true; } } @@ -628,7 +628,7 @@ w.id = r1; w.deg = D[r1]; w.dist = v.dist+1; - H_insert(S, s, w); + H_insert (S, s, w); visit[r1] = true; } j1++; @@ -642,7 +642,7 @@ w.id = r2; w.deg = D[r2]; w.dist = v.dist+1; - H_insert(S, s, w); + H_insert (S, s, w); visit[r2] = true; } j2++; @@ -656,7 +656,7 @@ OCTAVE_QUIT; // locate a neighbor of i with minimal degree in O(log(N)) - v = H_remove_min(S, s, 1); + v = H_remove_min (S, s, 1); // entered the BFS a new level? if (v.dist > level) @@ -700,9 +700,9 @@ s = N / 2 - 1; for (octave_idx_type i = 0, j = N - 1; i <= s; i++, j--) { - double tmp = P.elem(i); - P.elem(i) = P.elem(j); - P.elem(j) = tmp; + double tmp = P.elem (i); + P.elem (i) = P.elem (j); + P.elem (j) = tmp; } // increment all indices, since Octave is not C diff -r 72b8b39e12be -r 5ae9f0f77635 src/DLD-FUNCTIONS/tril.cc --- a/src/DLD-FUNCTIONS/tril.cc Mon Jul 09 10:34:43 2012 -0700 +++ b/src/DLD-FUNCTIONS/tril.cc Mon Jul 09 13:01:49 2012 -0700 @@ -137,8 +137,8 @@ octave_idx_type nc = m.cols (); for (octave_idx_type j = 0; j < nc; j++) - for (octave_idx_type i = m.cidx(j); i < m.cidx(j+1); i++) - if (m.ridx(i) < j-k) + for (octave_idx_type i = m.cidx (j); i < m.cidx (j+1); i++) + if (m.ridx (i) < j-k) m.data(i) = 0.; m.maybe_compress (true); @@ -159,8 +159,8 @@ octave_idx_type nc = m.cols (); for (octave_idx_type j = 0; j < nc; j++) - for (octave_idx_type i = m.cidx(j); i < m.cidx(j+1); i++) - if (m.ridx(i) > j-k) + for (octave_idx_type i = m.cidx (j); i < m.cidx (j+1); i++) + if (m.ridx (i) > j-k) m.data(i) = 0.; m.maybe_compress (true); @@ -290,8 +290,8 @@ idx_tmp.push_back (ov_idx); ov_idx(1) = static_cast (nc); tmp = tmp.resize (dim_vector (0,0)); - tmp = tmp.subsasgn("(",idx_tmp, arg.do_index_op (ov_idx)); - tmp = tmp.resize(dims); + tmp = tmp.subsasgn ("(",idx_tmp, arg.do_index_op (ov_idx)); + tmp = tmp.resize (dims); if (lower) { @@ -305,7 +305,7 @@ std::list idx; idx.push_back (ov_idx); - tmp = tmp.subsasgn ("(", idx, arg.do_index_op(ov_idx)); + tmp = tmp.subsasgn ("(", idx, arg.do_index_op (ov_idx)); if (error_state) return retval; @@ -323,7 +323,7 @@ std::list idx; idx.push_back (ov_idx); - tmp = tmp.subsasgn ("(", idx, arg.do_index_op(ov_idx)); + tmp = tmp.subsasgn ("(", idx, arg.do_index_op (ov_idx)); if (error_state) return retval; diff -r 72b8b39e12be -r 5ae9f0f77635 src/DLD-FUNCTIONS/urlwrite.cc --- a/src/DLD-FUNCTIONS/urlwrite.cc Mon Jul 09 10:34:43 2012 -0700 +++ b/src/DLD-FUNCTIONS/urlwrite.cc Mon Jul 09 13:01:49 2012 -0700 @@ -420,7 +420,7 @@ size_t pos = 0; while (true) { - pos = str.find_first_of('\n', pos); + pos = str.find_first_of ('\n', pos); if (pos == std::string::npos) break; pos++; @@ -430,7 +430,7 @@ pos = 0; for (octave_idx_type i = 0; i < n; i++) { - size_t newpos = str.find_first_of('\n', pos); + size_t newpos = str.find_first_of ('\n', pos); if (newpos == std::string::npos) break; @@ -467,11 +467,11 @@ { fileisdir = false; time_t ft; - curl_easy_getinfo(rep->handle (), CURLINFO_FILETIME, &ft); + curl_easy_getinfo (rep->handle (), CURLINFO_FILETIME, &ft); filetime = ft; double fs; - curl_easy_getinfo(rep->handle (), - CURLINFO_CONTENT_LENGTH_DOWNLOAD, &fs); + curl_easy_getinfo (rep->handle (), + CURLINFO_CONTENT_LENGTH_DOWNLOAD, &fs); filesize = fs; } } @@ -508,7 +508,7 @@ // Can I assume that the path is alway in "" on the last line size_t pos2 = retval.rfind ('"'); size_t pos1 = retval.rfind ('"', pos2 - 1); - retval = retval.substr(pos1 + 1, pos2 - pos1 - 1); + retval = retval.substr (pos1 + 1, pos2 - pos1 - 1); } setopt (CURLOPT_HEADERFUNCTION, 0); setopt (CURLOPT_WRITEHEADER, 0); @@ -608,7 +608,7 @@ curl_handles (void) : map () { - curl_global_init(CURL_GLOBAL_DEFAULT); + curl_global_init (CURL_GLOBAL_DEFAULT); } ~curl_handles (void)