changeset 28912:0de38a6ef693

maint: Use Octave convention of space after function name in scripts dir. * cplxpair.m, gradient.m, integral.m, integral3.m, interp2.m, interpft.m, num2str.m, pol2cart.m, quad2d.m, quadgk.m, quadl.m, repelem.m, sph2cart.m, convhull.m, delaunay.m, delaunayn.m, movegui.m, print_usage.m, __strip_html_tags__.m, colormap.m, gray2ind.m, imformats.m, importdata.m, javachk.m, condest.m, isbanded.m, krylov.m, lscov.m, rref.m, inputParser.m, publish.m, symvar.m, validateattributes.m, ode15i.m, ode15s.m, ode23.m, ode23s.m, ode45.m, fminbnd.m, fminsearch.m, glpk.m, qp.m, get_forge_pkg.m, installed_packages.m, annotation.m, axis.m, camorbit.m, campos.m, camva.m, camzoom.m, daspect.m, legend.m, pbaspect.m, __gnuplot_legend__.m, light.m, patch.m, plotyy.m, __pie__.m, reducepatch.m, ribbon.m, streamline.m, trisurf.m, figure.m, ndgrid.m, __gnuplot_draw_axes__.m, __opengl_print__.m, padecoef.m, polygcd.m, ppval.m, spline.m, union.m, bicg.m, bicgstab.m, cgs.m, eigs.m, gmres.m, pcg.m, pcr.m, __alltohandles__.m, __sprand__.m, qmr.m, tfqmr.m, betaincinv.m, cosint.m, gammainc.m, discrete_cdf.m, discrete_inv.m, discrete_rnd.m, base2dec.m, strtok.m, compare_plot_demos.m, html_compare_plot_demos.m, speed.m, test.m, weboptions.m, webread.m, webwrite.m: Use Octave convention of space after function name and before '(' in scripts directory.
author Rik <rik@octave.org>
date Tue, 13 Oct 2020 18:17:29 -0700
parents c001ae7f6726
children c11bebb62369
files scripts/general/cplxpair.m scripts/general/gradient.m scripts/general/integral.m scripts/general/integral3.m scripts/general/interp2.m scripts/general/interpft.m scripts/general/num2str.m scripts/general/pol2cart.m scripts/general/quad2d.m scripts/general/quadgk.m scripts/general/quadl.m scripts/general/repelem.m scripts/general/sph2cart.m scripts/geometry/convhull.m scripts/geometry/delaunay.m scripts/geometry/delaunayn.m scripts/gui/movegui.m scripts/help/print_usage.m scripts/help/private/__strip_html_tags__.m scripts/image/colormap.m scripts/image/gray2ind.m scripts/image/imformats.m scripts/io/importdata.m scripts/java/javachk.m scripts/linear-algebra/condest.m scripts/linear-algebra/isbanded.m scripts/linear-algebra/krylov.m scripts/linear-algebra/lscov.m scripts/linear-algebra/rref.m scripts/miscellaneous/inputParser.m scripts/miscellaneous/publish.m scripts/miscellaneous/symvar.m scripts/miscellaneous/validateattributes.m scripts/ode/ode15i.m scripts/ode/ode15s.m scripts/ode/ode23.m scripts/ode/ode23s.m scripts/ode/ode45.m scripts/optimization/fminbnd.m scripts/optimization/fminsearch.m scripts/optimization/glpk.m scripts/optimization/qp.m scripts/pkg/private/get_forge_pkg.m scripts/pkg/private/installed_packages.m scripts/plot/appearance/annotation.m scripts/plot/appearance/axis.m scripts/plot/appearance/camorbit.m scripts/plot/appearance/campos.m scripts/plot/appearance/camva.m scripts/plot/appearance/camzoom.m scripts/plot/appearance/daspect.m scripts/plot/appearance/legend.m scripts/plot/appearance/pbaspect.m scripts/plot/appearance/private/__gnuplot_legend__.m scripts/plot/draw/light.m scripts/plot/draw/patch.m scripts/plot/draw/plotyy.m scripts/plot/draw/private/__pie__.m scripts/plot/draw/reducepatch.m scripts/plot/draw/ribbon.m scripts/plot/draw/streamline.m scripts/plot/draw/trisurf.m scripts/plot/util/figure.m scripts/plot/util/ndgrid.m scripts/plot/util/private/__gnuplot_draw_axes__.m scripts/plot/util/private/__opengl_print__.m scripts/polynomial/padecoef.m scripts/polynomial/polygcd.m scripts/polynomial/ppval.m scripts/polynomial/spline.m scripts/set/union.m scripts/sparse/bicg.m scripts/sparse/bicgstab.m scripts/sparse/cgs.m scripts/sparse/eigs.m scripts/sparse/gmres.m scripts/sparse/pcg.m scripts/sparse/pcr.m scripts/sparse/private/__alltohandles__.m scripts/sparse/private/__sprand__.m scripts/sparse/qmr.m scripts/sparse/tfqmr.m scripts/specfun/betaincinv.m scripts/specfun/cosint.m scripts/specfun/gammainc.m scripts/statistics/discrete_cdf.m scripts/statistics/discrete_inv.m scripts/statistics/discrete_rnd.m scripts/strings/base2dec.m scripts/strings/strtok.m scripts/testfun/private/compare_plot_demos.m scripts/testfun/private/html_compare_plot_demos.m scripts/testfun/speed.m scripts/testfun/test.m scripts/web/weboptions.m scripts/web/webread.m scripts/web/webwrite.m
diffstat 97 files changed, 276 insertions(+), 276 deletions(-) [+]
line wrap: on
line diff
--- a/scripts/general/cplxpair.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/general/cplxpair.m	Tue Oct 13 18:17:29 2020 -0700
@@ -153,9 +153,9 @@
 
 %!shared z,y
 %! z = exp (2i*pi*[4; 3; 5; 2; 6; 1; 0]/7);
-%! z(2) = conj(z(1));
-%! z(4) = conj(z(3));
-%! z(6) = conj(z(5));
+%! z(2) = conj (z(1));
+%! z(4) = conj (z(3));
+%! z(6) = conj (z(5));
 %!assert (cplxpair (z(randperm (7))), z)
 %!assert (cplxpair (z(randperm (7))), z)
 %!assert (cplxpair (z(randperm (7))), z)
--- a/scripts/general/gradient.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/general/gradient.m	Tue Oct 13 18:17:29 2020 -0700
@@ -125,7 +125,7 @@
     endif
   else
     ## have spacing value for each dimension
-    if (length(varargin) != nd)
+    if (length (varargin) != nd)
       error ("gradient: dimensions and number of spacing values do not match");
     endif
     for i = 1:nd
--- a/scripts/general/integral.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/general/integral.m	Tue Oct 13 18:17:29 2020 -0700
@@ -181,13 +181,13 @@
 
       ## FIXME: Replace warning when have array compatible call with waypoints
       if (! isempty (waypoints))
-        warning(["integral: array-valued quadrature routine currently ", ...
+        warning (["integral: array-valued quadrature routine currently ", ...
                  "unable to handle WayPoints.  WayPoints are ignored."]);
       endif
 
       ## FIXME: Remove warning once we have reltol compatible arrayval'd quadfn
       if (! isempty (reltol))
-        warning(["integral: array-valued quadrature only accepts AbsTol.", ...
+        warning (["integral: array-valued quadrature only accepts AbsTol.", ...
                  "  RelTol ignored."]);
       endif
       if (isempty (abstol))
@@ -243,7 +243,7 @@
 %! assert (integral (@(x) f(x,5), 0, 2), -0.4605015338467329, 1e-10);
 
 %!test  # with tolerances
-%! f = @(x) log(x);
+%! f = @(x) log (x);
 %! assert (integral (@(x) f(x), 0, 1, "AbsTol", 1e-6), -1, 1e-6);
 
 %!test  # waypoints
@@ -256,11 +256,11 @@
 %!         1e-10);
 
 %!test  # test single input/output
-%! assert (integral (@sin, 0, 1), cos(0)-cos(1), 1e-10);
+%! assert (integral (@sin, 0, 1), cos (0)-cos (1), 1e-10);
 %! assert (class (integral (@sin, single (0), 1)), "single");
 %! assert (class (integral (@sin, 0, single (1))), "single");
 %! assert (class (integral (@sin, single (0), single (1))), "single");
-%! assert (integral (@sin, 0, 1, "Waypoints", 0.5), cos(0)-cos(1), 1e-10);
+%! assert (integral (@sin, 0, 1, "Waypoints", 0.5), cos (0)-cos (1), 1e-10);
 %! assert (class (integral (@sin, 0, 1, "Waypoints", single (0.5))), "single");
 %! assert (class (integral (@sin, single (0), 1, "Waypoints", 0.5)), "single");
 %! assert (class (integral (@sin, 0, single (1), "Waypoints", 0.5)), "single");
--- a/scripts/general/integral3.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/general/integral3.m	Tue Oct 13 18:17:29 2020 -0700
@@ -241,7 +241,7 @@
     if (! (isreal (za) && isscalar (za)))
       error ("integral3: ZA must be a real scalar or a function");
     endif
-    za = @(x, y) za * ones (size(y));
+    za = @(x, y) za * ones (size (y));
   endif
   if (! is_function_handle (zb))
     if (! (isreal (zb) && isscalar (zb)))
--- a/scripts/general/interp2.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/general/interp2.m	Tue Oct 13 18:17:29 2020 -0700
@@ -568,14 +568,14 @@
 %!error <X, Y must be numeric matrices> interp2 (1, {1}, ones (2), 1, 1)
 %!error <XI, YI must be numeric> interp2 (1, 1, ones (2), {1}, 1)
 %!error <XI, YI must be numeric> interp2 (1, 1, ones (2), 1, {1})
-%!error <X and Y must be matrices of equal size> interp2 (ones(2,2), 1, ones (2), 1, 1)
-%!error <X and Y must be matrices of equal size> interp2 (ones(2,2), ones(2,3), ones (2), 1, 1)
+%!error <X and Y must be matrices of equal size> interp2 (ones (2,2), 1, ones (2), 1, 1)
+%!error <X and Y must be matrices of equal size> interp2 (ones (2,2), ones (2,3), ones (2), 1, 1)
 %!error <X and Y size must match the dimensions of Z> interp2 (1:3, 1:3, ones (3,2), 1, 1)
 %!error <X and Y size must match the dimensions of Z> interp2 (1:2, 1:2, ones (3,2), 1, 1)
 %!error <X must be strictly monotonic> interp2 ([1 0 2], 1:3, ones (3,3), 1, 1)
 %!error <Y must be strictly monotonic> interp2 (1:3, [1 0 2], ones (3,3), 1, 1)
-%!error <XI and YI must be matrices of equal size> interp2 (1:2, 1:2, ones (2), ones(2,2), 1)
-%!error <XI and YI must be matrices of equal size> interp2 (1:2, 1:2, ones (2), 1, ones(2,2))
+%!error <XI and YI must be matrices of equal size> interp2 (1:2, 1:2, ones (2), ones (2,2), 1)
+%!error <XI and YI must be matrices of equal size> interp2 (1:2, 1:2, ones (2), 1, ones (2,2))
 %!error <XI, YI must have uniform spacing> interp2 (1:2, 1:2, ones (2), [1 2 4], [1 2 3], "spline")
 %!error <XI, YI must have uniform spacing> interp2 (1:2, 1:2, ones (2), [1 2 3], [1 2 4], "spline")
 %!error interp2 (1, 1, 1, 1, 1, "foobar")
--- a/scripts/general/interpft.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/general/interpft.m	Tue Oct 13 18:17:29 2020 -0700
@@ -111,9 +111,9 @@
 %! ti = t(1) + [0 : k-1]*dt*n/k;
 %! y = sin (4*t + 0.3) .* cos (3*t - 0.1);
 %! yp = sin (4*ti + 0.3) .* cos (3*ti - 0.1);
-%! plot (ti, yp, 'g', ti, interp1(t, y, ti, "spline"), 'b', ...
+%! plot (ti, yp, 'g', ti, interp1 (t, y, ti, "spline"), 'b', ...
 %!       ti, interpft (y, k), 'c', t, y, "r+");
-%! legend ("sin(4t+0.3)cos(3t-0.1)", "spline", "interpft", "data");
+%! legend ("sin (4t+0.3)cos (3t-0.1)", "spline", "interpft", "data");
 
 %!shared n,y
 %! x = [0:10]';  y = sin(x);  n = length (x);
--- a/scripts/general/num2str.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/general/num2str.m	Tue Oct 13 18:17:29 2020 -0700
@@ -211,8 +211,8 @@
 %!assert (num2str ([inf -inf]), "Inf -Inf")
 %!assert (num2str ([inf NaN -inf]), "Inf  NaN -Inf")
 %!assert (num2str ([complex(Inf,0), complex(0,-Inf)]), "Inf+0i   0-Infi")
-%!assert (num2str (complex(Inf,1)), "Inf+1i")
-%!assert (num2str (complex(1,Inf)), "1+Infi")
+%!assert (num2str (complex (Inf,1)), "Inf+1i")
+%!assert (num2str (complex (1,Inf)), "1+Infi")
 %!assert (num2str (nan), "NaN")
 %!assert (num2str (complex (NaN, 1)), "NaN+1i")
 %!assert (num2str (complex (1, NaN)), "1+NaNi")
@@ -249,7 +249,7 @@
 %!assert <*36133> (num2str (1e15), "1000000000000000")
 %!assert <*36133> (num2str (1e16), "1e+16")
 ## Even exact integers in IEEE notation should use exponential notation
-%!assert <*36133> (num2str(2^512), "1.34078079299426e+154")
+%!assert <*36133> (num2str (2^512), "1.34078079299426e+154")
 ## Mixed integer/floating point arrays
 %!assert <*36133> (num2str ([2.1, 1e23, pi]),
 %!                 "2.1  9.999999999999999e+22      3.141592653589793")
--- a/scripts/general/pol2cart.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/general/pol2cart.m	Tue Oct 13 18:17:29 2020 -0700
@@ -92,7 +92,7 @@
       theta = theta(1);
 
     else
-      ncols = columns(theta);
+      ncols = columns (theta);
       if (ncols != 2 && ncols != 3)
         error ("cart2pol: matrix input must be a 2- or 3-element vector or a 2- or 3-column array");
       endif
@@ -224,10 +224,10 @@
 %!test
 %! [t, r, Z] = meshgrid ([0, pi/2], [1, 2], [0, 1]);
 %! [x, y, z] = pol2cart (t, r, Z);
-%! X = zeros(2, 2, 2);
+%! X = zeros (2, 2, 2);
 %! X(:, 1, 1) = [1; 2];
 %! X(:, 1, 2) = [1; 2];
-%! Y = zeros(2, 2, 2);
+%! Y = zeros (2, 2, 2);
 %! Y(:, 2, 1) = [1; 2];
 %! Y(:, 2, 2) = [1; 2];
 %! assert (x, X, eps);
--- a/scripts/general/quad2d.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/general/quad2d.m	Tue Oct 13 18:17:29 2020 -0700
@@ -233,13 +233,13 @@
     if (! (isreal (ya) && isscalar (ya)))
       error ("quad2d: YA must be a real scalar or a function");
     endif
-    ya = @(x) ya * ones(rows (x), columns (x));
+    ya = @(x) ya * ones (rows (x), columns (x));
   endif
   if (! is_function_handle (yb))
     if (! (isreal (yb) && isscalar (yb)))
       error ("quad2d: YB must be a real scalar or a function");
     endif
-    yb = @(x) yb * ones(rows (x), columns (x));
+    yb = @(x) yb * ones (rows (x), columns (x));
   endif
 
   iter = 0;
@@ -262,7 +262,7 @@
 
     xtrans = @(tx) ((xa - xb) .* cos (tx) + (xa + xb)) ./ 2;
     ytrans = @(ty) (1 - cos (ty)) ./ 2;
-    ztrans = @(tx, ty) (xb - xa) .* sin(tx) .* sin(ty) ./ 4;
+    ztrans = @(tx, ty) (xb - xa) .* sin (tx) .* sin (ty) ./ 4;
     area = pi ^ 2;
 
     ## Initialize tile list
--- a/scripts/general/quadgk.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/general/quadgk.m	Tue Oct 13 18:17:29 2020 -0700
@@ -463,7 +463,7 @@
 function t = __quadgk_finite_waypoint__ (x, a, b)
   c = (-4 .* x + 2.* (b + a)) ./ (b - a);
   k = ((sqrt (c .^ 2 - 4) + c) ./ 2) .^ (1/3);
-  t = real ((sqrt(3) .* 1i * (1 - k .^ 2) - (1 + k .^ 2)) ./ 2 ./ k);
+  t = real ((sqrt (3) .* 1i * (1 - k .^ 2) - (1 + k .^ 2)) ./ 2 ./ k);
 endfunction
 
 
@@ -480,10 +480,10 @@
 %!assert (quadgk (@(x) 1./sqrt (x),0,1), 2, 1e-10)
 %!assert (quadgk (@(x) abs (1 - x.^2),0,2, "Waypoints", 1), 2, 1e-10)
 %!assert (quadgk (@(x) 1./(sqrt (x) .* (x+1)),0,Inf), pi, 1e-10)
-%!assert <*57614> (quadgk (@(z) exp(z)./z, 1, 1,
+%!assert <*57614> (quadgk (@(z) exp (z)./z, 1, 1,
 %!                        "Waypoints", [1+i, -1+i, -1-i, 1-i]),
 %!                 complex (0, 2*pi), 1e-10)
-%!assert <*57614> (quadgk (@(z) exp(z)./z, 1, 1,
+%!assert <*57614> (quadgk (@(z) exp (z)./z, 1, 1,
 %!                        "Waypoints", [1-i, -1-i, -1+i, 1+i]),
 %!                 complex (0, -2*pi), 1e-10)
 %!assert (quadgk (@(z) log (z),1+1i,1+1i, "WayPoints", [1-1i, -1,-1i, -1+1i]),
--- a/scripts/general/quadl.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/general/quadl.m	Tue Oct 13 18:17:29 2020 -0700
@@ -184,14 +184,14 @@
 
 ## extra parameters
 %!assert (quadl (@(x,a,b) sin (a + b*x), 0, 1, [], [], 2, 3),
-%!        cos(2)/3 - cos(5)/3, 1e-6)
+%!        cos (2)/3 - cos (5)/3, 1e-6)
 
 ## test different tolerances.
 %!test
 %! [q, nfun1] = quadl (@(x) sin (2 + 3*x).^2, 0, 10, 0.5, []);
-%! assert (q, (60 + sin(4) - sin(64))/12, 0.5);
+%! assert (q, (60 + sin (4) - sin (64))/12, 0.5);
 %! [q, nfun2] = quadl (@(x) sin (2 + 3*x).^2, 0, 10, 0.1, []);
-%! assert (q, (60 + sin(4) - sin(64))/12, 0.1);
+%! assert (q, (60 + sin (4) - sin (64))/12, 0.1);
 %! assert (nfun2 > nfun1);
 
 %!test  # test single input/output
--- a/scripts/general/repelem.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/general/repelem.m	Tue Oct 13 18:17:29 2020 -0700
@@ -364,32 +364,32 @@
 %!        [1 1 1 0 0;1 1 1 0 0;0 0 0 -1 -1;0 0 0 -1 -1;0 0 0 -1 -1])
 %!assert (repelem (cat(3,[1 1 1 0;0 1 0 0],[1 1 1 1;0 0 0 1],[1 0 0 1;1 1 0 1]),
 %!                2, 3),
-%!        cat(3,[1 1 1 1 1 1 1 1 1 0 0 0
-%!               1 1 1 1 1 1 1 1 1 0 0 0
-%!               0 0 0 1 1 1 0 0 0 0 0 0
-%!               0 0 0 1 1 1 0 0 0 0 0 0],
-%!              [1 1 1 1 1 1 1 1 1 1 1 1
-%!               1 1 1 1 1 1 1 1 1 1 1 1
-%!               0 0 0 0 0 0 0 0 0 1 1 1
-%!               0 0 0 0 0 0 0 0 0 1 1 1],
-%!              [1 1 1 0 0 0 0 0 0 1 1 1
-%!               1 1 1 0 0 0 0 0 0 1 1 1
-%!               1 1 1 1 1 1 0 0 0 1 1 1
-%!               1 1 1 1 1 1 0 0 0 1 1 1]))
+%!        cat (3,[1 1 1 1 1 1 1 1 1 0 0 0
+%!                1 1 1 1 1 1 1 1 1 0 0 0
+%!                0 0 0 1 1 1 0 0 0 0 0 0
+%!                0 0 0 1 1 1 0 0 0 0 0 0],
+%!               [1 1 1 1 1 1 1 1 1 1 1 1
+%!                1 1 1 1 1 1 1 1 1 1 1 1
+%!                0 0 0 0 0 0 0 0 0 1 1 1
+%!                0 0 0 0 0 0 0 0 0 1 1 1],
+%!               [1 1 1 0 0 0 0 0 0 1 1 1
+%!                1 1 1 0 0 0 0 0 0 1 1 1
+%!                1 1 1 1 1 1 0 0 0 1 1 1
+%!                1 1 1 1 1 1 0 0 0 1 1 1]))
 %!assert (repelem (cat(3,[1 1 1 0;0 1 0 0],[1 1 1 1;0 0 0 1],[1 0 0 1;1 1 0 1]),
 %!                2, [3 3 3 3]), ...
-%!        cat(3,[1 1 1 1 1 1 1 1 1 0 0 0
-%!               1 1 1 1 1 1 1 1 1 0 0 0
-%!               0 0 0 1 1 1 0 0 0 0 0 0
-%!               0 0 0 1 1 1 0 0 0 0 0 0], ...
-%!              [1 1 1 1 1 1 1 1 1 1 1 1
-%!               1 1 1 1 1 1 1 1 1 1 1 1
-%!               0 0 0 0 0 0 0 0 0 1 1 1
-%!               0 0 0 0 0 0 0 0 0 1 1 1], ...
-%!              [1 1 1 0 0 0 0 0 0 1 1 1
-%!               1 1 1 0 0 0 0 0 0 1 1 1
-%!               1 1 1 1 1 1 0 0 0 1 1 1
-%!               1 1 1 1 1 1 0 0 0 1 1 1]));
+%!        cat (3,[1 1 1 1 1 1 1 1 1 0 0 0
+%!                1 1 1 1 1 1 1 1 1 0 0 0
+%!                0 0 0 1 1 1 0 0 0 0 0 0
+%!                0 0 0 1 1 1 0 0 0 0 0 0], ...
+%!               [1 1 1 1 1 1 1 1 1 1 1 1
+%!                1 1 1 1 1 1 1 1 1 1 1 1
+%!                0 0 0 0 0 0 0 0 0 1 1 1
+%!                0 0 0 0 0 0 0 0 0 1 1 1], ...
+%!               [1 1 1 0 0 0 0 0 0 1 1 1
+%!                1 1 1 0 0 0 0 0 0 1 1 1
+%!                1 1 1 1 1 1 0 0 0 1 1 1
+%!                1 1 1 1 1 1 0 0 0 1 1 1]));
 %!assert (repelem ([1 2 3 4 5], 2,[2 1 2 0 2]), [1 1 2 3 3 5 5;1 1 2 3 3 5 5])
 %
 ## nargin > 3 tests
@@ -405,16 +405,16 @@
 %!assert (repelem (repmat([-1 0;0 1],1,1,2,3),2,2,2,2,2), ...
 %!        repmat([-1 -1 0 0;-1 -1 0 0;0 0 1 1; 0 0 1 1],1,1,4,6,2))
 %!assert (repelem ([1,0,-1;-1,0,1],[2 3],[2 3 4],2), ...
-%!        cat(3,[ 1  1 0 0 0 -1 -1 -1 -1
-%!                1  1 0 0 0 -1 -1 -1 -1
-%!               -1 -1 0 0 0  1  1  1  1
-%!               -1 -1 0 0 0  1  1  1  1
-%!               -1 -1 0 0 0  1  1  1  1], ...
-%!              [ 1  1 0 0 0 -1 -1 -1 -1
-%!                1  1 0 0 0 -1 -1 -1 -1
-%!               -1 -1 0 0 0  1  1  1  1
-%!               -1 -1 0 0 0  1  1  1  1
-%!               -1 -1 0 0 0  1  1  1  1]));
+%!        cat (3,[ 1  1 0 0 0 -1 -1 -1 -1
+%!                 1  1 0 0 0 -1 -1 -1 -1
+%!                -1 -1 0 0 0  1  1  1  1
+%!                -1 -1 0 0 0  1  1  1  1
+%!                -1 -1 0 0 0  1  1  1  1], ...
+%!               [ 1  1 0 0 0 -1 -1 -1 -1
+%!                 1  1 0 0 0 -1 -1 -1 -1
+%!                -1 -1 0 0 0  1  1  1  1
+%!                -1 -1 0 0 0  1  1  1  1
+%!                -1 -1 0 0 0  1  1  1  1]));
 %!assert (repelem ([1 2 3;4 5 6],[0 2],2,2), repmat([4 4 5 5 6 6],2,1,2))
 
 ## test with structures
--- a/scripts/general/sph2cart.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/general/sph2cart.m	Tue Oct 13 18:17:29 2020 -0700
@@ -178,11 +178,11 @@
 %!test
 %! [t, p, r] = meshgrid ([0, pi/2], [0, pi/2], [0, 1]);
 %! [x, y, z] = sph2cart (t, p, r);
-%! X = zeros(2, 2, 2);
+%! X = zeros (2, 2, 2);
 %! X(1, 1, 2) = 1;
-%! Y = zeros(2, 2, 2);
+%! Y = zeros (2, 2, 2);
 %! Y(1, 2, 2) = 1;
-%! Z = zeros(2, 2, 2);
+%! Z = zeros (2, 2, 2);
 %! Z(2, :, 2) = [1 1];
 %! assert (x, X, eps);
 %! assert (y, Y, eps);
--- a/scripts/geometry/convhull.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/geometry/convhull.m	Tue Oct 13 18:17:29 2020 -0700
@@ -196,9 +196,9 @@
 %!error <Invalid call> convhull ()
 %!error <Invalid call> convhull (1,2,3,4,5)
 %!error <X must be a matrix with 2 or 3 columns> convhull (ones (2,4))
-%!error <OPTIONS must be a string or cell array> convhull (ones (2,2), struct())
+%!error <OPTIONS must be a string or cell array> convhull (ones (2,2), struct ())
 %!error <X must be a matrix with 2 or 3 columns> convhull (ones (2,4), "")
-%!error <OPTIONS must be a string or cell array> convhull (ones (2,2), ones (2,2), struct())
-%!error <OPTIONS must be a string or cell array> convhull (ones (2,2), ones (2,2), ones (2,2), struct())
+%!error <OPTIONS must be a string or cell array> convhull (ones (2,2), ones (2,2), struct ())
+%!error <OPTIONS must be a string or cell array> convhull (ones (2,2), ones (2,2), ones (2,2), struct ())
 %!error <X and Y must be the same size> convhull (1, [1 2])
 %!error <X, Y, and Z must be the same size> convhull (1, [1 2], [1 2])
--- a/scripts/geometry/delaunay.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/geometry/delaunay.m	Tue Oct 13 18:17:29 2020 -0700
@@ -212,9 +212,9 @@
 %!error <Invalid call> delaunay ()
 %!error <Invalid call> delaunay (1,2,3,4,5)
 %!error <X must be a matrix with 2 or 3 columns> delaunay (ones (2,4))
-%!error <OPTIONS must be a string or cell array> delaunay (ones (2,2), struct())
+%!error <OPTIONS must be a string or cell array> delaunay (ones (2,2), struct ())
 %!error <X must be a matrix with 2 or 3 columns> delaunay (ones (2,4), "")
-%!error <OPTIONS must be a string or cell array> delaunay (ones (2,2), ones (2,2), struct())
-%!error <OPTIONS must be a string or cell array> delaunay (ones (2,2), ones (2,2), ones (2,2), struct())
+%!error <OPTIONS must be a string or cell array> delaunay (ones (2,2), ones (2,2), struct ())
+%!error <OPTIONS must be a string or cell array> delaunay (ones (2,2), ones (2,2), ones (2,2), struct ())
 %!error <X and Y must be the same size> delaunay (1, [1 2])
 %!error <X, Y, and Z must be the same size> delaunay (1, [1 2], [1 2])
--- a/scripts/geometry/delaunayn.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/geometry/delaunayn.m	Tue Oct 13 18:17:29 2020 -0700
@@ -106,8 +106,8 @@
     p12 = p1 - p2;
     p23 = p2 - p3;
     det = cross (p12, p23, 2);
-    idx = abs (det(:,3) ./ sqrt (sumsq (p12, 2))) < tol & ...
-          abs (det(:,3) ./ sqrt (sumsq (p23, 2))) < tol;
+    idx = abs (det (:,3) ./ sqrt (sumsq (p12, 2))) < tol & ...
+          abs (det (:,3) ./ sqrt (sumsq (p23, 2))) < tol;
   else
     ## FIXME: Vectorize this for loop or convert delaunayn to .oct function
     idx = [];
--- a/scripts/gui/movegui.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/gui/movegui.m	Tue Oct 13 18:17:29 2020 -0700
@@ -185,8 +185,8 @@
         if (fpos(2) > y(3))
           fpos(2) = y(3) - 30;
         endif
-        fpos(1) = max(fpos(1), 30);
-        fpos(2) = max(fpos(2), 30);
+        fpos(1) = max (fpos(1), 30);
+        fpos(2) = max (fpos(2), 30);
       otherwise
         error ("movegui: invalid position");
     endswitch
--- a/scripts/help/print_usage.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/help/print_usage.m	Tue Oct 13 18:17:29 2020 -0700
@@ -45,7 +45,7 @@
       error ("Octave:invalid-context", "print_usage: invalid function\n");
     endif
     fullname = evalin ("caller", 'mfilename ("fullpath")');
-    if (strcmp (fullname(end-length(name)+1:end), name))
+    if (strcmp (fullname(end-length (name)+1:end), name))
       fullname = [fullname ".m"];
     endif
   elseif (! ischar (name))
--- a/scripts/help/private/__strip_html_tags__.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/help/private/__strip_html_tags__.m	Tue Oct 13 18:17:29 2020 -0700
@@ -37,7 +37,7 @@
   stop  = find (html_text == ">");
   if (length (start) == length (stop))
     text = html_text;
-    for n = length(start):-1:1
+    for n = length (start):-1:1
       text (start (n):stop (n)) = [];
     endfor
     text = strip_superfluous_endlines (text);
--- a/scripts/image/colormap.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/image/colormap.m	Tue Oct 13 18:17:29 2020 -0700
@@ -177,7 +177,7 @@
 %!error colormap (1,2,3)
 %!error <MAP must be a real-valued N x 3> colormap ({1,2,3})
 %!error <MAP must be a real-valued N x 3> colormap ([1 i 1])
-%!error <MAP must be a real-valued N x 3> colormap (ones(3,3,3))
+%!error <MAP must be a real-valued N x 3> colormap (ones (3,3,3))
 %!error <MAP must be a real-valued N x 3> colormap ([1 0 1 0])
 %!error <all MAP values must be in the range> colormap ([-1 0 0])
 %!error <all MAP values must be in the range> colormap ([2 0 0])
--- a/scripts/image/gray2ind.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/image/gray2ind.m	Tue Oct 13 18:17:29 2020 -0700
@@ -44,7 +44,7 @@
 
   if (nargin < 1)
     print_usage ();
-  elseif (! isreal (I) || issparse (I) || ! ismatrix(I))
+  elseif (! isreal (I) || issparse (I) || ! ismatrix (I))
     error ("gray2ind: I must be a grayscale or binary image");
   elseif (! isscalar (n) || n < 1 || n > 65536)
     error ("gray2ind: N must be a positive integer in the range [1, 65536]");
--- a/scripts/image/imformats.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/image/imformats.m	Tue Oct 13 18:17:29 2020 -0700
@@ -243,7 +243,7 @@
             "XWD",  {"xwd"},          false;
             };
 
-  for fidx = 1: rows(coders)
+  for fidx = 1:rows (coders)
     formats(fidx).coder = coders{fidx, 1};
     formats(fidx).ext   = coders{fidx, 2};
     formats(fidx).alpha = coders{fidx, 3};
@@ -387,7 +387,7 @@
 %! unwind_protect
 %!   fmt = imformats ("jpg"); # take jpg as template
 %!   fmt.ext = "new_fmt1";
-%!   fmt.read = @(~) true();
+%!   fmt.read = @(~) true ();
 %!   fmt(2) = fmt(1);
 %!   fmt(2).ext = "new_fmt2";
 %!   imformats ("add", fmt);
--- a/scripts/io/importdata.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/io/importdata.m	Tue Oct 13 18:17:29 2020 -0700
@@ -82,7 +82,7 @@
   if (nargin > 1)
     if (! ischar (delimiter)
         || (length (delimiter) > 1 && ! strcmp (delimiter, '\t')))
-      error("importdata: DELIMITER must be a single character");
+      error ("importdata: DELIMITER must be a single character");
     endif
     if (strcmp (delimiter, '\t'))
       delimiter = "\t";
--- a/scripts/java/javachk.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/java/javachk.m	Tue Oct 13 18:17:29 2020 -0700
@@ -133,7 +133,7 @@
 endfunction
 
 
-%!testif ; ! __octave_config_info__().build_features.JAVA
+%!testif ; ! __octave_config_info__ ().build_features.JAVA
 %! msg = javachk ("desktop");
 %! assert (msg.message, "javachk: this function is not supported, Octave was not compiled with Java support");
 %! assert (msg.identifier, "Octave:javachk:java-not-supported");
--- a/scripts/linear-algebra/condest.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/linear-algebra/condest.m	Tue Oct 13 18:17:29 2020 -0700
@@ -181,12 +181,12 @@
     endif
   elseif (is_function_handle (varargin{1}))
     if (nargin == 1)
-      error("condest: must provide AINVFCN when using AFCN");
+      error ("condest: must provide AINVFCN when using AFCN");
     endif
     Afcn = varargin{1};
     have_Afcn = true;
     if (! is_function_handle (varargin{2}))
-      error("condest: AINVFCN must be a function handle");
+      error ("condest: AINVFCN must be a function handle");
     endif
     Ainvfcn = varargin{2};
     have_Ainvfcn = true;
--- a/scripts/linear-algebra/isbanded.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/linear-algebra/isbanded.m	Tue Oct 13 18:17:29 2020 -0700
@@ -69,9 +69,9 @@
 
 %!assert (isbanded ([1, 1],1,1))
 %!assert (isbanded ([1; 1],1,1))
-%!assert (isbanded (eye(10),0,0))
-%!assert (isbanded (eye(10),1,1))
-%!assert (isbanded (i*eye(10),1,1))
+%!assert (isbanded (eye (10),0,0))
+%!assert (isbanded (eye (10),1,1))
+%!assert (isbanded (i*eye (10),1,1))
 %!assert (isbanded (logical (eye (10)),1,1))
 
 %! A = [2 3 0 0 0; 1 2 3 0 0; 0 1 2 3 0; 0 0 1 2 3; 0 0 0 1 2];
--- a/scripts/linear-algebra/krylov.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/linear-algebra/krylov.m	Tue Oct 13 18:17:29 2020 -0700
@@ -187,7 +187,7 @@
     if ((columns (V) > na) && (length (alpha) == na))
       ## Trim to size.
       V = V(:,1:na);
-    elseif (columns(V) > na)
+    elseif (columns (V) > na)
       krylov_V = V;
       krylov_na = na;
       krylov_length_alpha = length (alpha);
@@ -198,7 +198,7 @@
       ## Construct next Q and multiply.
       Q = zeros (size (V));
       for kk = 1:columns (Q)
-        Q(pivot_vec(nu-columns(Q)+kk),kk) = 1;
+        Q(pivot_vec(nu-columns (Q)+kk),kk) = 1;
       endfor
 
       ## Apply Householder reflections.
@@ -218,7 +218,7 @@
       hv = U(:,i);
       av = alpha(i);
       V -= av*hv*(hv'*V);
-      H(i,nu-columns(V)+(1:columns(V))) = V(pivot_vec(i),:);
+      H(i,nu-columns (V)+(1:columns (V))) = V(pivot_vec(i),:);
     endfor
 
   endwhile
--- a/scripts/linear-algebra/lscov.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/linear-algebra/lscov.m	Tue Oct 13 18:17:29 2020 -0700
@@ -167,9 +167,9 @@
 %! y = Z(:,1); X = [ones(rows(Z),1), Z(:,2:end)];
 %! alpha = 0.05;
 %! [b, stdb, mse] = lscov (X, y);
-%! assert(b, V(:,1), 3e-6);
-%! assert(stdb, V(:,2), -1.e-5);
-%! assert(sqrt (mse), rsd, -1E-6);
+%! assert (b, V(:,1), 3e-6);
+%! assert (stdb, V(:,2), -1.e-5);
+%! assert (sqrt (mse), rsd, -1E-6);
 
 %!test
 %! ## Adapted from example in Matlab documentation
@@ -178,37 +178,37 @@
 %! X = [ones(size(x1)) x1 x2];
 %! y = [.17 .26 .28 .23 .27 .34]';
 %! [b, se_b, mse, S] = lscov(X, y);
-%! assert(b, [0.1203 0.3284 -0.1312]', 1E-4);
-%! assert(se_b, [0.0643 0.2267 0.1488]', 1E-4);
-%! assert(mse, 0.0015, 1E-4);
-%! assert(S, [0.0041 -0.0130 0.0075; -0.0130 0.0514 -0.0328; 0.0075 -0.0328 0.0221], 1E-4);
+%! assert (b, [0.1203 0.3284 -0.1312]', 1E-4);
+%! assert (se_b, [0.0643 0.2267 0.1488]', 1E-4);
+%! assert (mse, 0.0015, 1E-4);
+%! assert (S, [0.0041 -0.0130 0.0075; -0.0130 0.0514 -0.0328; 0.0075 -0.0328 0.0221], 1E-4);
 %! w = [1 1 1 1 1 .1]';
 %! [bw, sew_b, msew] = lscov (X, y, w);
-%! assert(bw, [0.1046 0.4614 -0.2621]', 1E-4);
-%! assert(sew_b, [0.0309 0.1152 0.0814]', 1E-4);
-%! assert(msew, 3.4741e-004, -1E-4);
-%! V = .2*ones(length(x1)) + .8*diag(ones(size(x1)));
+%! assert (bw, [0.1046 0.4614 -0.2621]', 1E-4);
+%! assert (sew_b, [0.0309 0.1152 0.0814]', 1E-4);
+%! assert (msew, 3.4741e-004, -1E-4);
+%! V = .2*ones (length (x1)) + .8*diag (ones (size (x1)));
 %! [bg, sew_b, mseg] = lscov (X, y, V);
-%! assert(bg, [0.1203 0.3284 -0.1312]', 1E-4);
-%! assert(sew_b, [0.0672 0.2267 0.1488]', 1E-4);
-%! assert(mseg, 0.0019, 1E-4);
+%! assert (bg, [0.1203 0.3284 -0.1312]', 1E-4);
+%! assert (sew_b, [0.0672 0.2267 0.1488]', 1E-4);
+%! assert (mseg, 0.0019, 1E-4);
 %! y2 = [y 2*y];
 %! [b2, se_b2, mse2, S2] = lscov (X, y2);
-%! assert(b2, [b 2*b], 2*eps);
-%! assert(se_b2, [se_b 2*se_b], 2*eps);
-%! assert(mse2, [mse 4*mse], eps);
-%! assert(S2(:, :, 1), S, eps);
-%! assert(S2(:, :, 2), 4*S, eps);
+%! assert (b2, [b 2*b], 2*eps);
+%! assert (se_b2, [se_b 2*se_b], 2*eps);
+%! assert (mse2, [mse 4*mse], eps);
+%! assert (S2(:, :, 1), S, eps);
+%! assert (S2(:, :, 2), 4*S, eps);
 
 %!test
 %! ## Artificial example with positive semi-definite weight matrix
 %! x = (0:0.2:2)';
-%! y = round(100*sin(x) + 200*cos(x));
+%! y = round (100*sin (x) + 200*cos (x));
 %! X = [ones(size(x)) sin(x) cos(x)];
-%! V = eye(numel(x));
+%! V = eye (numel (x));
 %! V(end, end-1) = V(end-1, end) = 1;
 %! [b, seb, mseb, S] = lscov (X, y, V);
-%! assert(b, [0 100 200]', 0.2);
+%! assert (b, [0 100 200]', 0.2);
 
 ## Test input validation
 %!error <Invalid call> lscov ()
--- a/scripts/linear-algebra/rref.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/linear-algebra/rref.m	Tue Oct 13 18:17:29 2020 -0700
@@ -111,7 +111,7 @@
 %! a = [1 3; 4 5; 7 9];
 %! [r k] = rref (a);
 %! assert (rank (a), rank (r), 2e-8);
-%! assert (r, eye(3)(:,1:2), 2e-8);
+%! assert (r, eye (3)(:,1:2), 2e-8);
 %! assert (k, [1 2], 2e-8);
 
 %!test
--- a/scripts/miscellaneous/inputParser.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/miscellaneous/inputParser.m	Tue Oct 13 18:17:29 2020 -0700
@@ -441,7 +441,7 @@
           else
             this.error (sprintf (["failed validation of %s\n", ...
                                   "Validation function: %s"],
-                                 toupper (opt.name), disp(opt.val)));
+                                 toupper (opt.name), disp (opt.val)));
           endif
         endif
         this.Results.(opt.name) = in;
--- a/scripts/miscellaneous/publish.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/miscellaneous/publish.m	Tue Oct 13 18:17:29 2020 -0700
@@ -611,7 +611,7 @@
   ## Extract <html> and <latex> blocks recursively.
   content_str = strjoin (content, "\n");
   tags = {"html", "latex"};
-  for i = 1:length(tags)
+  for i = 1:length (tags)
     tok = regexp (content_str, ...
       ['(.*?)(^|\n\n)(<', tags{i}, '>)\n(.*?)\n(<\/', ...
         tags{i}, '>)($|\n\n)(.*)'], "tokens", "once");
--- a/scripts/miscellaneous/symvar.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/miscellaneous/symvar.m	Tue Oct 13 18:17:29 2020 -0700
@@ -58,5 +58,5 @@
 
 
 %!assert (symvar ("3*x + 4*y + 5*cos (z)"), {"x"; "y"; "z"})
-%!assert (symvar ("sin()^2 + cos()^2 == 1"), {})
+%!assert (symvar ("sin ()^2 + cos ()^2 == 1"), {})
 %!assert (symvar ("1./x"), {"x"})
--- a/scripts/miscellaneous/validateattributes.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/miscellaneous/validateattributes.m	Tue Oct 13 18:17:29 2020 -0700
@@ -424,7 +424,7 @@
   num_pos = strcmpi (cls, name);
   if (any (num_pos))
     cls(num_pos) = [];
-    cls(end+1:end+numel(group)) = group;
+    cls(end+1:end+numel (group)) = group;
   endif
 endfunction
 
--- a/scripts/ode/ode15i.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/ode/ode15i.m	Tue Oct 13 18:17:29 2020 -0700
@@ -388,11 +388,11 @@
 
 ## With empty options
 %!testif HAVE_SUNDIALS
-%! opt = odeset();
+%! opt = odeset ();
 %! [t, y] = ode15i (@rob, [0, 1e6, 2e6, 3e6, 4e6], [1; 0; 0],
 %!                  [-1e-4; 1e-4; 0], opt);
 %! assert ([t(end), y(end,:)], fref2, 1e-3);
-%! opt = odeset();
+%! opt = odeset ();
 
 ## Without options
 %!testif HAVE_SUNDIALS
--- a/scripts/ode/ode15s.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/ode/ode15s.m	Tue Oct 13 18:17:29 2020 -0700
@@ -467,9 +467,9 @@
 %!endfunction
 %!
 %!function jac = jacfunsparse (t, y)
-%!  jac = sparse([-0.04,           1e4*y(3),  1e4*y(2);
-%!                 0.04, -1e4*y(3)-6e7*y(2), -1e4*y(2);
-%!                    1,                  1,         1]);
+%!  jac = sparse ([-0.04,           1e4*y(3),  1e4*y(2);
+%!                  0.04, -1e4*y(3)-6e7*y(2), -1e4*y(2);
+%!                     1,                  1,         1]);
 %!endfunction
 
 %!testif HAVE_SUNDIALS
--- a/scripts/ode/ode23.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/ode/ode23.m	Tue Oct 13 18:17:29 2020 -0700
@@ -426,7 +426,7 @@
 %!test # hermite_cubic_interpolation
 %! opt = odeset ("RelTol", 1e-8, "NormControl", "on");
 %! [t,sol] = ode23(@(t,x)[x(2);x(1)],linspace(0,1),[1;0],opt);
-%! assert(max(abs(sol(:,1)-cosh(t))),0,1e-6)
+%! assert (max (abs (sol(:,1)-cosh (t))),0,1e-6)
 %!test  # RelTol and NormControl option -- higher accuracy
 %! opt = odeset ("RelTol", 1e-8, "NormControl", "on");
 %! sol = ode23 (@fpol, [0 2], [2 0], opt);
--- a/scripts/ode/ode23s.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/ode/ode23s.m	Tue Oct 13 18:17:29 2020 -0700
@@ -283,7 +283,7 @@
 %! [vt, vy] = ode23s (fun, [0 20], [2 0]);
 %! toc ()
 %! ## Plotting the result
-%! plot(vt,vy(:,1),'-o');
+%! plot (vt,vy(:,1),'-o');
 
 %!demo
 %! ## Demo function: stiff Van Der Pol equation
@@ -295,7 +295,7 @@
 %! [vt, vy] = ode23s (fun, [0 20], [2 0], odeopts);
 %! toc ()
 %! ## Plotting the result
-%! plot(vt,vy(:,1),'-o');
+%! plot (vt,vy(:,1),'-o');
 
 %!demo
 %! ## Demo function: stiff Van Der Pol equation
@@ -306,7 +306,7 @@
 %! [vt, vy] = ode23s (fun, [0 200], [2 0]);
 %! toc ()
 %! ## Plotting the result
-%! plot(vt,vy(:,1),'-o');
+%! plot (vt,vy(:,1),'-o');
 
 %!demo
 %! ## Demo function: stiff Van Der Pol equation
@@ -318,7 +318,7 @@
 %! [vt, vy] = ode23s (fun, [0 200], [2 0], odeopts);
 %! toc ()
 %! ## Plotting the result
-%! plot(vt,vy(:,1),'-o');
+%! plot (vt,vy(:,1),'-o');
 
 %!demo
 %! ## Demonstrate convergence order for ode23s
--- a/scripts/ode/ode45.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/ode/ode45.m	Tue Oct 13 18:17:29 2020 -0700
@@ -401,7 +401,7 @@
 %! assert ([sol.x(5)-sol.x(4)], [1e-3], 1e-3);
 %!test  # Solve with intermediate step
 %! [t, y] = ode45 (@fpol, [0 1 2], [2 0]);
-%! assert (any((t-1) == 0));
+%! assert (any ((t-1) == 0));
 %! assert ([t(end), y(end,:)], [2, fref], 1e-3);
 %!test  # Solve in backward direction starting at t=0
 %! vref = [-1.205364552835178, 0.951542399860817];
@@ -414,7 +414,7 @@
 %!test  # Solve in backward direction starting at t=2, with intermediate step
 %! vref = [-1.205364552835178, 0.951542399860817];
 %! [t, y] = ode45 (@fpol, [2 0 -2], fref);
-%! idx = find(y < 0, 1, "first") - 1;
+%! idx = find (y < 0, 1, "first") - 1;
 %! assert ([t(idx), y(idx,:)], [0,2,0], 1e-2);
 %! assert ([t(end), y(end,:)], [-2, vref], 1e-2);
 %!test  # Solve another anonymous function in backward direction
--- a/scripts/optimization/fminbnd.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/optimization/fminbnd.m	Tue Oct 13 18:17:29 2020 -0700
@@ -288,15 +288,15 @@
 function print_formatted_table (table)
   printf ("\n Func-count     x          f(x)         Procedure\n");
   for row=table
-    printf("%5.5s        %7.7s    %8.8s\t%s\n",
-           int2str (row.funccount), num2str (row.x,"%.5f"),
-           num2str (row.fx,"%.6f"), row.procedure);
+    printf ("%5.5s        %7.7s    %8.8s\t%s\n",
+            int2str (row.funccount), num2str (row.x,"%.5f"),
+            num2str (row.fx,"%.6f"), row.procedure);
   endfor
   printf ("\n");
 endfunction
 
 ## Print either a success termination message or bad news
-function print_exit_msg (info, opt=struct())
+function print_exit_msg (info, opt=struct ())
   printf ("");
   switch (info)
     case 1
--- a/scripts/optimization/fminsearch.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/optimization/fminsearch.m	Tue Oct 13 18:17:29 2020 -0700
@@ -311,7 +311,7 @@
     endfor
   else
     ## Right-angled simplex based on co-ordinate axes.
-    alpha = scale * ones(n+1,1);
+    alpha = scale * ones (n+1,1);
     for j = 2:n+1
       V(:,j) = x0 + alpha(j)*V(:,j);
       x(:) = V(:,j);
@@ -362,7 +362,7 @@
       printf ("Iter. %2.0f,", k);
       printf ("  how = %-11s", [how ","]);
       printf ("nf = %3.0f,  f = %9.4e  (%2.1f%%)\n", nf, dirn * fmax, ...
-              100*(fmax-fmax_old)/(abs(fmax_old)+eps));
+              100*(fmax-fmax_old)/(abs (fmax_old)+eps));
     endif
     fmax_old = fmax;
 
--- a/scripts/optimization/glpk.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/optimization/glpk.m	Tue Oct 13 18:17:29 2020 -0700
@@ -667,9 +667,9 @@
 %! assert (fmin, c' * xmin);
 %! assert (A * xmin, b);
 
-%!error<C .* finite values> glpk(NaN, 2, 3)
-%!error<A must be finite> glpk(1, NaN, 3)
-%!error<B must be finite> glpk(1, 2, NaN)
-%!error<LB must be a real-valued> glpk(1, 2, 3, NaN)
-%!error<UB must be a real-valued> glpk(1, 2, 3, 4, NaN)
-%!error<SENSE must be .* integer> glpk(1, 2, 3, 4, 5, "F", "C", NaN)
+%!error <C .* finite values> glpk (NaN, 2, 3)
+%!error <A must be finite> glpk (1, NaN, 3)
+%!error <B must be finite> glpk (1, 2, NaN)
+%!error <LB must be a real-valued> glpk (1, 2, 3, NaN)
+%!error <UB must be a real-valued> glpk (1, 2, 3, 4, NaN)
+%!error <SENSE must be .* integer> glpk (1, 2, 3, 4, 5, "F", "C", NaN)
--- a/scripts/optimization/qp.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/optimization/qp.m	Tue Oct 13 18:17:29 2020 -0700
@@ -273,8 +273,8 @@
   endif
 
   ## Validate inequality constraints.
-  if (nargs > 7 && isempty (A_in) && ! (isempty(A_lb) || isempty(A_ub)))
-    warning("qp: empty inequality constraint matrix but non-empty bound vectors");
+  if (nargs > 7 && isempty (A_in) && ! (isempty (A_lb) || isempty (A_ub)))
+    warning ("qp: empty inequality constraint matrix but non-empty bound vectors");
   endif
 
   if (nargs > 7 && ! isempty (A_in))
--- a/scripts/pkg/private/get_forge_pkg.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/pkg/private/get_forge_pkg.m	Tue Oct 13 18:17:29 2020 -0700
@@ -47,7 +47,7 @@
                                    name));
   if (succ)
     ## Remove blanks for simpler matching.
-    html(isspace(html)) = [];
+    html(isspace (html)) = [];
     ## Good.  Let's grep for the version.
     pat = "<tdclass=""package_table"">PackageVersion:</td><td>([\\d.]*)</td>";
     t = regexp (html, pat, "tokens");
--- a/scripts/pkg/private/installed_packages.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/pkg/private/installed_packages.m	Tue Oct 13 18:17:29 2020 -0700
@@ -134,8 +134,8 @@
     header = sprintf ("%s | %s | %s\n", h1, h2, h3);
     printf (header);
     tmp = sprintf (repmat ("-", 1, length (header) - 1));
-    tmp(length(h1)+2) = "+";
-    tmp(length(h1)+length(h2)+5) = "+";
+    tmp(length (h1)+2) = "+";
+    tmp(length (h1)+length (h2)+5) = "+";
     printf ("%s\n", tmp);
 
     ## Print the packages.
--- a/scripts/plot/appearance/annotation.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/plot/appearance/annotation.m	Tue Oct 13 18:17:29 2020 -0700
@@ -1133,7 +1133,7 @@
 
 function XY = textcoordinates (hte, pos)
   ## Get the "tight" extent of the text object in points units
-  textpos = get(hte, "position");
+  textpos = get (hte, "position");
   rot = get (hte, "rotation");
   units = get (hte, "units");
 
@@ -1453,8 +1453,8 @@
 %! xl = xlim ();
 %! yl = [-1.2 1.5];
 %! ylim (yl);
-%! x0 = (x0 - xl(1)) / diff(xl);
-%! y0 = (y0 - yl(1)) / diff(yl);
+%! x0 = (x0 - xl(1)) / diff (xl);
+%! y0 = (y0 - yl(1)) / diff (yl);
 %!
 %! pos = get (gca (), "position");
 %! x0 = x0*pos(3) + pos(1);
--- a/scripts/plot/appearance/axis.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/plot/appearance/axis.m	Tue Oct 13 18:17:29 2020 -0700
@@ -587,14 +587,14 @@
 %!  axis ("autoy");
 %!
 %! subplot (326);
-%!  plot (t, sin(t), t, -2*sin(t/2));
+%!  plot (t, sin (t), t, -2*sin (t/2));
 %!  axis ("tight");
 %!  title ("tight");
 
 %!demo
 %! clf;
 %! x = 0:0.1:10;
-%! plot (x, sin(x));
+%! plot (x, sin (x));
 %! axis image;
 %! title ({"image", 'equivalent to "tight" & "equal"'});
 
--- a/scripts/plot/appearance/camorbit.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/plot/appearance/camorbit.m	Tue Oct 13 18:17:29 2020 -0700
@@ -219,7 +219,7 @@
 %! hf = figure ("visible", "off");
 %! unwind_protect
 %!   sphere ();
-%!   camorbit(20, 30, "camera")
+%!   camorbit (20, 30, "camera")
 %!   p = campos ();
 %!   u = camup ();
 %!   ## Matlab 2008a
--- a/scripts/plot/appearance/campos.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/plot/appearance/campos.m	Tue Oct 13 18:17:29 2020 -0700
@@ -145,7 +145,7 @@
 %!test
 %! hf = figure ("visible", "off");
 %! unwind_protect
-%!   sphere();
+%!   sphere ();
 %!   p_orig = campos ();
 %!   m = campos ("mode");
 %!   assert (strcmp (m, "auto"));
--- a/scripts/plot/appearance/camva.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/plot/appearance/camva.m	Tue Oct 13 18:17:29 2020 -0700
@@ -135,7 +135,7 @@
 %!test
 %! hf = figure ("visible", "off");
 %! unwind_protect
-%!   sphere();
+%!   sphere ();
 %!   a_orig = camva ();
 %!   m = camva ("mode");
 %!   assert (strcmp (m, "auto"));
--- a/scripts/plot/appearance/camzoom.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/plot/appearance/camzoom.m	Tue Oct 13 18:17:29 2020 -0700
@@ -114,7 +114,7 @@
 %!test
 %! hf = figure ("visible", "off");
 %! unwind_protect
-%!   sphere();
+%!   sphere ();
 %!   x = camva ();
 %!   camzoom (2);
 %!   y = camva ();
--- a/scripts/plot/appearance/daspect.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/plot/appearance/daspect.m	Tue Oct 13 18:17:29 2020 -0700
@@ -104,7 +104,7 @@
 %!demo
 %! clf;
 %! x = 0:0.01:4;
-%! plot (x,cos(x), x,sin(x));
+%! plot (x,cos (x), x,sin (x));
 %! axis square;
 %! daspect ([1 1 1]);
 %! title ("square plot box with axis limits [0, 4, -2, 2]");
@@ -120,7 +120,7 @@
 %!demo
 %! clf;
 %! x = 0:0.01:4;
-%! plot (x,cos(x), x,sin(x));
+%! plot (x,cos (x), x,sin (x));
 %! daspect ([1 2 1]);
 %! pbaspect ([2 1 1]);
 %! title ("2x1 plot box with axis limits [0, 4, -2, 2]");
@@ -128,7 +128,7 @@
 %!demo
 %! clf;
 %! x = 0:0.01:4;
-%! plot (x,cos(x), x, sin(x));
+%! plot (x,cos (x), x, sin (x));
 %! axis square;
 %! set (gca, "positionconstraint", "innerposition");
 %! daspect ([1 1 1]);
@@ -137,7 +137,7 @@
 %!demo
 %! clf;
 %! x = 0:0.01:4;
-%! plot (x,cos(x), x,sin(x));
+%! plot (x,cos (x), x,sin (x));
 %! axis ([0 4 -1 1]);
 %! set (gca, "positionconstraint", "innerposition");
 %! daspect ([2 1 1]);
--- a/scripts/plot/appearance/legend.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/plot/appearance/legend.m	Tue Oct 13 18:17:29 2020 -0700
@@ -895,7 +895,7 @@
     return;
   endif
 
-  setappdata(hl, "__updating_layout__", true);
+  setappdata (hl, "__updating_layout__", true);
 
   ## Scale limits so that item positions are expressed in points, from
   ## top to bottom and from left to right or reverse depending on textposition
@@ -927,7 +927,7 @@
 
   unwind_protect_cleanup
     set (hl, "units", units);
-    setappdata(hl, "__updating_layout__", false);
+    setappdata (hl, "__updating_layout__", false);
   end_unwind_protect
 
 endfunction
@@ -1237,7 +1237,7 @@
 
     nrow = ceil (nitem / ncol);
 
-    colwidth = arrayfun (@(idx) max(ext(idx:ncol:end, 1)),
+    colwidth = arrayfun (@(idx) max (ext(idx:ncol:end, 1)),
                          1:ncol);
     y = vmargin;
     for ii = 1:nrow
@@ -1340,7 +1340,7 @@
       set (hicon, "markerxdata", x0, "markerydata", y0, ...
            "xdata", xdata, "ydata", ydata);
     case "__scatter__"
-      set (hicon, "xdata", mean(xdata), "ydata", mean(ydata));
+      set (hicon, "xdata", mean (xdata), "ydata", mean (ydata));
     case "__stem__"
       xdata(2) -= (get (get (hicon, "peer_object"), "markersize") / 2);
       set (hicon, "markerxdata", xdata(2), "markerydata", mean (ydata), ...
@@ -1742,7 +1742,7 @@
 %!demo
 %! clf;
 %! x = 0:0.1:7;
-%! h = plot (x,sin(x), x,cos(x), x,sin(x.^2/10), x,cos(x.^2/10));
+%! h = plot (x,sin (x), x,cos (x), x,sin (x.^2/10), x,cos (x.^2/10));
 %! title ("Only the sin() objects have keylabels");
 %! legend (h([1, 3]), {"sin (x)", "sin (x^2/10)"}, "location", "southwest");
 
--- a/scripts/plot/appearance/pbaspect.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/plot/appearance/pbaspect.m	Tue Oct 13 18:17:29 2020 -0700
@@ -105,21 +105,21 @@
 %!demo
 %! clf;
 %! x = 0:0.01:4;
-%! plot (x,cos(x), x,sin(x));
+%! plot (x,cos (x), x,sin (x));
 %! pbaspect ([1 1 1]);
 %! title ("plot box is square");
 
 %!demo
 %! clf;
 %! x = 0:0.01:4;;
-%! plot (x,cos(x), x,sin(x));
+%! plot (x,cos (x), x,sin (x));
 %! pbaspect ([2 1 1]);
 %! title ("plot box aspect ratio is 2x1");
 
 %!demo
 %! clf;
 %! x = 0:0.01:4;
-%! plot (x,cos(x), x,sin(x));
+%! plot (x,cos (x), x,sin (x));
 %! daspect ([1 1 1]);
 %! pbaspect ([2 1 1]);
 %! title ("plot box is 2x1, and axes [0 4 -1 1]");
--- a/scripts/plot/appearance/private/__gnuplot_legend__.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/plot/appearance/private/__gnuplot_legend__.m	Tue Oct 13 18:17:29 2020 -0700
@@ -1557,7 +1557,7 @@
 %!demo
 %! clf;
 %! x = 0:0.1:7;
-%! h = plot (x,sin(x), x,cos(x), x,sin(x.^2/10), x,cos(x.^2/10));
+%! h = plot (x,sin (x), x,cos (x), x,sin (x.^2/10), x,cos (x.^2/10));
 %! title ("Only the sin() objects have keylabels");
 %! legend (h([1, 3]), {"sin (x)", "sin (x^2/10)"}, "location", "southwest");
 
--- a/scripts/plot/draw/light.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/plot/draw/light.m	Tue Oct 13 18:17:29 2020 -0700
@@ -163,9 +163,9 @@
 %! h_axes1 = axes ();
 %! surf (X, Y, Z, "LineStyle", "none", "FaceLighting", "none");
 %! hold on;
-%! surf (X + round(1.2 * size (Z, 2)), Y, Z, "LineStyle", "none", ...
+%! surf (X + round (1.2 * size (Z, 2)), Y, Z, "LineStyle", "none", ...
 %!       "FaceLighting", "flat");
-%! surf (X + round(2.4 * size (Z, 2)), Y, Z, "LineStyle", "none", ...
+%! surf (X + round (2.4 * size (Z, 2)), Y, Z, "LineStyle", "none", ...
 %!       "FaceLighting", "gouraud");
 %! axis tight
 %! axis equal
--- a/scripts/plot/draw/patch.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/plot/draw/patch.m	Tue Oct 13 18:17:29 2020 -0700
@@ -254,7 +254,7 @@
 %! ha = axes ();
 %! hp = patch ("Vertices", vertices, "Faces", faces, "FaceColor", "g");
 %! xlabel ("x"), ylabel ("y"), zlabel ("z");
-%! view(3);
+%! view (3);
 %! set (ha, "XTick", [], "YTick", [], "ZTick", []);
 %! text (vertices(1,1), vertices(1,2), vertices(1,3), "1");
 %! text (vertices(2,1), vertices(2,2), vertices(2,3), "2");
--- a/scripts/plot/draw/plotyy.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/plot/draw/plotyy.m	Tue Oct 13 18:17:29 2020 -0700
@@ -87,7 +87,7 @@
       hax = get (hax, "__plotyy_axes__");
     else
       hax = [hax; axes("nextplot", get (hax(1), "nextplot"), ...
-                       "parent", get(hax(1), "parent"))];
+                       "parent", get (hax(1), "parent"))];
     endif
 
     [axtmp, h1tmp, h2tmp] = __plotyy__ (hax, varargin{:});
@@ -155,7 +155,7 @@
   endif
 
   set (ax(2), "units", get (ax(1), "units"));
-  if (strcmp (get(ax(1), "positionconstraint"), "innerposition"))
+  if (strcmp (get (ax(1), "positionconstraint"), "innerposition"))
     set (ax(2), "position", get (ax(1), "position"));
   else
     set (ax(2), {"outerposition", "looseinset"},
@@ -286,13 +286,13 @@
 %! colormap ("default");
 %! x = linspace (-1, 1, 201);
 %! subplot (2,2,1);
-%!  plotyy (x,sin(pi*x), x,10*cos(pi*x));
+%!  plotyy (x,sin (pi*x), x,10*cos (pi*x));
 %!  title ("plotyy() in subplot");
 %! subplot (2,2,2);
 %!  surf (peaks (25));
 %! subplot (2,2,3);
 %!  contour (peaks (25));
 %! subplot (2,2,4);
-%!  plotyy (x,10*sin(2*pi*x), x,cos(2*pi*x));
+%!  plotyy (x,10*sin (2*pi*x), x,cos (2*pi*x));
 %!  title ("plotyy() in subplot");
 %!  axis square;
--- a/scripts/plot/draw/private/__pie__.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/plot/draw/private/__pie__.m	Tue Oct 13 18:17:29 2020 -0700
@@ -130,7 +130,7 @@
 
       hlist = [hlist;
         patch(xoff + [0, -sind(xn)], yoff + [0, cosd(xn)], zeros (1, ln + 1), i);
-        surface(sx, sy, sz, sc);
+        surface (sx, sy, sz, sc);
         patch(xoff + [0, -sind(xn)], yoff + [0, cosd(xn)], zlvl * ones (1, ln + 1), i);
         text(xt, yt, zlvl, labels{i})];
 
--- a/scripts/plot/draw/reducepatch.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/plot/draw/reducepatch.m	Tue Oct 13 18:17:29 2020 -0700
@@ -363,7 +363,7 @@
 %! patch (fv, "FaceColor", "g");
 %! view (3);  axis equal;
 %! title ("Sphere with all faces");
-%! ax2 = subplot(1, 2, 2);
+%! ax2 = subplot (1, 2, 2);
 %! patch (reducepatch (fv, 72), "FaceColor", "g");
 %! view (3);  axis equal;
 %! title ("Sphere with reduced number of faces");
--- a/scripts/plot/draw/ribbon.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/plot/draw/ribbon.m	Tue Oct 13 18:17:29 2020 -0700
@@ -60,7 +60,7 @@
     if (isvector (y))
       y = y(:);
     endif
-    x = 1:rows(y);
+    x = 1:rows (y);
     width = 0.75;
   elseif (nargin == 2)
     x = varargin{1};
@@ -122,6 +122,6 @@
 %! colormap ("default");
 %! [x, y, z] = sombrero ();
 %! ribbon (y, z);
-%! title ("ribbon() plot of sombrero()");
+%! title ("ribbon() plot of sombrero ()");
 
 %!FIXME: Could have some input validation tests here
--- a/scripts/plot/draw/streamline.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/plot/draw/streamline.m	Tue Oct 13 18:17:29 2020 -0700
@@ -154,7 +154,7 @@
 %! sy = 0.0;
 %! sz = 0.0;
 %! plot3 (sx, sy, sz, ".r", "markersize", 15);
-%! t = linspace (0, 12 * 2 * pi(), 500);
+%! t = linspace (0, 12 * 2 * pi (), 500);
 %! tx = exp (-a * t).*cos (t);
 %! ty = exp (-a * t).*sin (t);
 %! tz = - b * t;
--- a/scripts/plot/draw/trisurf.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/plot/draw/trisurf.m	Tue Oct 13 18:17:29 2020 -0700
@@ -138,7 +138,7 @@
 %! z = peaks (x, y);
 %! tri = delaunay (x(:), y(:));
 %! trisurf (tri, x(:), y(:), z(:));
-%! title ("trisurf() of sparsely-sampled triangulation of peaks()");
+%! title ("trisurf () of sparsely-sampled triangulation of peaks ()");
 
 %!demo
 %! clf;
--- a/scripts/plot/util/figure.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/plot/util/figure.m	Tue Oct 13 18:17:29 2020 -0700
@@ -85,7 +85,7 @@
   ## Check to see if we already have a figure on the screen.  If we do,
   ## then update it if it is different from the figure we are creating
   ## or switching to.
-  cf = get (0, "currentfigure");   # Can't use gcf () because it calls figure()
+  cf = get (0, "currentfigure");   # Can't use gcf() because it calls figure()
   if (! isempty (cf) && cf != 0)
     if (init_new_figure || cf != f)
       drawnow ();
--- a/scripts/plot/util/ndgrid.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/plot/util/ndgrid.m	Tue Oct 13 18:17:29 2020 -0700
@@ -95,8 +95,8 @@
 %! x = 1:3;
 %! [XX, YY] = ndgrid (x);
 %! assert (size_equal (XX, YY));
-%! assert (isequal (XX, repmat(x(:), 1, numel(x))));
-%! assert (isequal (YY, repmat(x, numel(x), 1)));
+%! assert (isequal (XX, repmat (x(:), 1, numel (x))));
+%! assert (isequal (YY, repmat (x, numel (x), 1)));
 
 %!test
 %! x = 1:2;
@@ -124,7 +124,7 @@
 %! assert (XX1, XX2.');
 %! assert (YY1, YY2.');
 
-%!assert (ndgrid ([]), zeros(0,1))
+%!assert (ndgrid ([]), zeros (0,1))
 %!assert (ndgrid ([], []), zeros(0,0))
 
 ## Test input validation
--- a/scripts/plot/util/private/__gnuplot_draw_axes__.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/plot/util/private/__gnuplot_draw_axes__.m	Tue Oct 13 18:17:29 2020 -0700
@@ -152,7 +152,7 @@
     fputs (plot_stream, "unset title;\n");
   else
     if (nd == 2)
-      t = get(axis_obj.title);
+      t = get (axis_obj.title);
       colorspec = get_text_colorspec (t.color);
       [tt, f, s] = __maybe_munge_text__ (enhanced, t, "string", t.interpreter);
       fontspec = create_fontspec (f, s, gnuplot_term);
@@ -168,7 +168,7 @@
         unwind_protect_cleanup
         end_unwind_protect
       endif
-      t = get(axis_obj.title);
+      t = get (axis_obj.title);
       axispos = axis_obj.position;
       screenpos = t.position;
       screenpos(1) = axispos(1)+screenpos(1)*axispos(3);
@@ -869,7 +869,7 @@
 
               if (nd == 3 && numel (xcol) == 3)
                 if (isnan (ccdat))
-                  ccdat = (cmap_sz + rows (addedcmap) + 1) * ones(3, 1);
+                  ccdat = (cmap_sz + rows (addedcmap) + 1) * ones (3, 1);
                   addedcmap = [addedcmap; reshape(color, 1, 3)];
                 elseif (numel (ccdat) == 1)
                   ccdat = ccdat * ones (size (zcol));
@@ -1980,7 +1980,7 @@
       endif
     endif
   endif
-  if (! isempty(pt) && isfield (obj, "markeredgecolor")
+  if (! isempty (pt) && isfield (obj, "markeredgecolor")
       && ! strcmp (obj.markeredgecolor, "none"))
     if (facesame && (strcmp (obj.markeredgecolor, "auto")
         || (isnumeric (obj.markeredgecolor)
@@ -2532,8 +2532,8 @@
                  '{}', str(e(i) + b2(1) + 1:end)];
         endif
       elseif (strcmp (f, "fontsize"))
-        b1 = strfind (str(e(i) + 1:end),'{');
-        b2 = strfind (str(e(i) + 1:end),'}');
+        b1 = strfind (str(e (i) + 1:end),'{');
+        b2 = strfind (str(e (i) + 1:end),'}');
         if (isempty (b1) || isempty (b2))
           warning ('syntax error in \fontname argument');
         else
--- a/scripts/plot/util/private/__opengl_print__.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/plot/util/private/__opengl_print__.m	Tue Oct 13 18:17:29 2020 -0700
@@ -100,7 +100,7 @@
         cmd_pstoedit = opts.pstoedit_cmd (opts, "fig", false);
         [~, ~, ext] = fileparts (opts.name);
         if (any (strcmpi (ext, {".ps", ".tex", "."})))
-          opts.name = opts.name(1:end-numel(ext));
+          opts.name = opts.name(1:end-numel (ext));
         endif
         opts.name = [opts.name ".ps"];
         cmd = sprintf ('%s | %s > "%s"', cmd_pstoedit, cmd_fig2dev, opts.name);
@@ -109,7 +109,7 @@
         cmd_fig2dev = opts.fig2dev_cmd (opts, "pstex_t");
         gl2ps_device{2} = "eps";
         pipeline{2} = sprintf ('%s | %s > "%s"', cmd_pstoedit,
-                               cmd_fig2dev, strrep(opts.name, ".ps", ".tex"));
+                               cmd_fig2dev, strrep (opts.name, ".ps", ".tex"));
       else
         ## Using svgconvert
         tmp = tempname ();
--- a/scripts/polynomial/padecoef.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/polynomial/padecoef.m	Tue Oct 13 18:17:29 2020 -0700
@@ -163,7 +163,7 @@
 %! x = A \ b';
 %! k = N : -1 : 0;
 %! d_exp = [flipud(x(N + 2 : 2 * N + 1)); 1]';
-%! n_exp = flipud(x(1 : N + 1))';
+%! n_exp = flipud (x(1 : N + 1))';
 %! n_exp ./= d_exp(1);
 %! d_exp ./= d_exp(1);
 %! [n_obs, d_obs] = padecoef (T, N);
--- a/scripts/polynomial/polygcd.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/polynomial/polygcd.m	Tue Oct 13 18:17:29 2020 -0700
@@ -84,7 +84,7 @@
         x = a;
         break;
       else
-        r = r(nz(1):length(r));
+        r = r(nz(1):length (r));
       endif
       b = a;
       a = r / r(1);
--- a/scripts/polynomial/ppval.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/polynomial/ppval.m	Tue Oct 13 18:17:29 2020 -0700
@@ -61,7 +61,7 @@
   P = reshape (P, [d, n * k]);
   P = shiftdim (P, nd);
   P = reshape (P, [n, k, d]);
-  Pidx = P(idx(:), :);  # 2D matrix size: x = coefs*prod(d), y = prod(sxi)
+  Pidx = P(idx(:), :);  # 2D matrix size: x = coefs*prod (d), y = prod (sxi)
 
   if (isvector (xi))
     Pidx = reshape (Pidx, [xn, k, d]);
--- a/scripts/polynomial/spline.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/polynomial/spline.m	Tue Oct 13 18:17:29 2020 -0700
@@ -228,7 +228,7 @@
 %! x = 0:10; y = sin (x);
 %! xspline = 0:0.1:10;  yspline = spline (x,y,xspline);
 %! title ("spline fit to points from sin (x)");
-%! plot (xspline,sin(xspline),"r", xspline,yspline,"g-", x,y,"b+");
+%! plot (xspline,sin (xspline),"r", xspline,yspline,"g-", x,y,"b+");
 %! legend ("original", "interpolation", "interpolation points");
 %! %--------------------------------------------------------
 %! % confirm that interpolated function matches the original
--- a/scripts/set/union.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/set/union.m	Tue Oct 13 18:17:29 2020 -0700
@@ -195,12 +195,12 @@
 %!error <cells not supported with "rows"> union ({"a"}, {"b"}, "rows","legacy")
 %!error <A and B must be arrays or cell arrays> union (@sin, 1, "rows")
 %!error <A and B must be arrays or cell arrays> union (@sin,1,"rows","legacy")
-%!error <A and B must be 2-dimensional matrices> union (rand(2,2,2), 1, "rows")
-%!error <A and B must be 2-dimensional matrices> union (1, rand(2,2,2), "rows")
+%!error <A and B must be 2-dimensional matrices> union (rand (2,2,2), 1, "rows")
+%!error <A and B must be 2-dimensional matrices> union (1, rand (2,2,2), "rows")
 %!error <A and B must be 2-dimensional matrices>
-%! union (rand(2,2,2), 1, "rows", "legacy");
+%! union (rand (2,2,2), 1, "rows", "legacy");
 %!error <A and B must be 2-dimensional matrices>
-%! union (1, rand(2,2,2), "rows", "legacy");
+%! union (1, rand (2,2,2), "rows", "legacy");
 %!error <number of columns in A and B must match> union ([1 2], 1, "rows")
 %!error <number of columns in A and B must match> union (1, [1 2], "rows")
 %!error <number of columns in A and B must match>
--- a/scripts/sparse/bicg.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/sparse/bicg.m	Tue Oct 13 18:17:29 2020 -0700
@@ -236,7 +236,7 @@
   endif
   norm_b = norm (b, 2);
 
-  if (norm_b == 0)  # the only (only iff det(A) == 0) solution is x = 0
+  if (norm_b == 0)  # the only (only iff det (A) == 0) solution is x = 0
     if (nargout < 2)
       printf ("The right hand side vector is all zero so bicg\n")
       printf ("returned an all zero solution without iterating.\n")
--- a/scripts/sparse/bicgstab.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/sparse/bicgstab.m	Tue Oct 13 18:17:29 2020 -0700
@@ -215,12 +215,12 @@
 
   # Check if input tol are empty (set them to default if necessary)
   [tol, maxit, x0] = __default__input__ ({1e-06, min(rows(b), 20), ...
-                    zeros(rows(b), 1)}, tol, maxit, x0);
+                    zeros(rows (b), 1)}, tol, maxit, x0);
 
   norm_b = norm (b, 2);
   if (norm_b == 0)
     if (nargout < 2)
-      printf("The right hand side vector is all zero so bicgstab \n")
+      printf ("The right hand side vector is all zero so bicgstab \n")
       printf ("returned an all zero solution without iterating.\n")
     endif
     x_min = zeros (numel (b), 1);
@@ -248,7 +248,7 @@
 
   ## To check if the preconditioners are singular or they have some NaN
   try
-    warning("error", "Octave:singular-matrix", "local");
+    warning ("error", "Octave:singular-matrix", "local");
     p_hat = feval (M1fun, p, varargin{:});
     p_hat = feval (M2fun, p_hat, varargin{:});
   catch
--- a/scripts/sparse/cgs.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/sparse/cgs.m	Tue Oct 13 18:17:29 2020 -0700
@@ -199,12 +199,12 @@
   [Afun, M1fun, M2fun] = __alltohandles__ (A, b, M1, M2, "cgs");
 
   [tol, maxit, x0] = __default__input__ ({1e-06, min( rows(b), 20), ...
-                                          zeros(size(b))}, tol, maxit, x0);
+                                          zeros(size (b))}, tol, maxit, x0);
 
   norm_b = norm (b, 2);
   if (norm_b == 0)
     if (nargout < 2)
-      printf("The right hand side vector is all zero so cgs \n")
+      printf ("The right hand side vector is all zero so cgs \n")
       printf ("returned an all zero solution without iterating.\n")
     endif
     x_min = zeros (numel (b), 1);
@@ -252,7 +252,7 @@
     r0 -= alpha* feval (Afun, u_hat, varargin{:});
     iter += 1;
     resvec (iter + 1) = norm (r0, 2);
-    if (norm (x - x_pr, 2) <= norm(x, 2) * eps) # Stagnation
+    if (norm (x - x_pr, 2) <= norm (x, 2) * eps) # Stagnation
       flag = 3;
       break;
     endif
@@ -379,7 +379,7 @@
 %! M1_fun = @(z) M1 \ z;
 %! M2_fun = @(z) M2 \ z;
 %! [x, flag] = cgs (A,b);
-%! assert(flag, 0);
+%! assert (flag, 0);
 %! [x, flag] = cgs (A, b, [], maxit, M1, M2);
 %! assert (flag, 0);
 %! [x, flag] = cgs (A, b, [], maxit, M1_fun, M2_fun);
--- a/scripts/sparse/eigs.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/sparse/eigs.m	Tue Oct 13 18:17:29 2020 -0700
@@ -1482,11 +1482,11 @@
 %! i_A = [1, 2, 3, 4, 5, 6, 7, 8, 9, 10];
 %! j_A = [1, 2, 3, 4, 5, 6, 7,  8, 9, 10];
 %! v_A = [1, 2i, 3, 4i, 5, 6i, 7, 8, 9, 10i];
-%! A = sparse(i_A, j_A, v_A);
+%! A = sparse (i_A, j_A, v_A);
 %! i_B = [1,2, 3, 4, 5, 6, 7, 8, 9, 10];
 %! j_B = [1, 2, 3, 4, 5, 6, 7, 8, 9, 10];
 %! v_B = [3, 10i, 1, 8i, 7, 6i, 5, 4i, 9, 7i];
-%! B = sparse(i_B, j_B, v_B); # not SPD
+%! B = sparse (i_B, j_B, v_B); # not SPD
 %! [Evectors, Evalues] = eigs(A, B, 5, "SM"); # call_eig is true
 %! ResidualVectors = A * Evectors - B * Evectors * Evalues;
 %! RelativeErrors = norm (ResidualVectors, "columns") ./ ...
--- a/scripts/sparse/gmres.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/sparse/gmres.m	Tue Oct 13 18:17:29 2020 -0700
@@ -258,9 +258,9 @@
   size_b = rows (b);
 
   if (tol >= 1)
-    warning("Input tol is bigger than 1. \n Try to use a smaller tolerance.");
+    warning ("Input tol is bigger than 1. \n Try to use a smaller tolerance.");
   elseif (tol <= eps / 2)
-    warning("Input tol may not be achievable by gmres. \n Try to use a bigger tolerance.");
+    warning ("Input tol may not be achievable by gmres. \n Try to use a bigger tolerance.");
   endif
 
   ## This big "if block" is to set maxit and restart in the proper way
@@ -303,7 +303,7 @@
   prec_b_norm = norm (b, 2);
   if (prec_b_norm == 0)
     if (nargout < 2)
-      printf("The right hand side vector is all zero so gmres\nreturned an all zero solution without iterating.\n")
+      printf ("The right hand side vector is all zero so gmres\nreturned an all zero solution without iterating.\n")
     endif
     x_min = b;
     flag = 0;
@@ -324,14 +324,14 @@
   iter_min = 0; # iteration with minimum residual
   outer_it = 1; # number of outer iterations
   restart_it  =  1; # number of inner iterations
-  it = zeros(1, 2);
+  it = zeros (1, 2);
   resvec = zeros (max_iter_number + 1, 1);
   flag = 1; # Default flag is maximum # of iterations exceeded
 
   ## begin loop
   u = feval (Afun, x_old, varargin{:});
   try
-    warning("error", "Octave:singular-matrix", "local")
+    warning ("error", "Octave:singular-matrix", "local");
     prec_res = feval (M1fun, b - u, varargin{:}); # M1*(b-u)
     prec_res = feval (M2fun, prec_res, varargin{:});
     presn = norm (prec_res, 2);
@@ -401,22 +401,22 @@
   if ((nargout < 2) && (restart != size_b)) # restart applied
     switch (flag)
       case {0} # gmres converged
-        printf ("gmres(%d) converged at outer iteration %d (inner iteration %d) ",restart, it (1), it (2));
+        printf ("gmres (%d) converged at outer iteration %d (inner iteration %d) ",restart, it (1), it (2));
         printf ("to a solution with relative residual %d \n", relres);
       case {1} # max number of iteration reached
-        printf ("gmres(%d) stopped at outer iteration %d (inner iteration %d) ", restart, outer_it, restart_it-1);
+        printf ("gmres (%d) stopped at outer iteration %d (inner iteration %d) ", restart, outer_it, restart_it-1);
         printf ("without converging to the desired tolerance %d ", tol);
         printf ("because the maximum number of iterations was reached \n");
         printf ("The iterated returned (number %d(%d)) ", it(1), it(2));
         printf ("has relative residual %d \n", relres);
       case {2} # preconditioner singular
-        printf ("gmres(%d) stopped at outer iteration %d (inner iteration %d) ",restart, outer_it, restart_it-1);
+        printf ("gmres (%d) stopped at outer iteration %d (inner iteration %d) ",restart, outer_it, restart_it-1);
         printf ("without converging to the desired tolerance %d ", tol);
         printf ("because the preconditioner matrix is singular \n");
         printf ("The iterated returned (number %d(%d)) ", it(1), it(2));
         printf ("has relative residual %d \n", relres);
       case {3} # stagnation
-        printf ("gmres(%d) stopped at outer iteration %d (inner iteration %d) ", restart, outer_it, restart_it - 1);
+        printf ("gmres (%d) stopped at outer iteration %d (inner iteration %d) ", restart, outer_it, restart_it - 1);
         printf ("without converging to the desired tolerance %d", tol);
         printf ("because it stagnates. \n");
         printf ("The iterated returned (number %d(%d)) ", it(1), it(2));
@@ -539,7 +539,7 @@
 %! [x, flag] = gmres (A, b, 10, 1e-10, dim, @(x) x ./ diag (A), [], b);
 %! assert (x, A\b, 1e-9*norm (x, Inf));
 %! [x, flag] = gmres (A, b, dim, 1e-10, 1e4, @(x) diag (diag (A)) \ x, [], b);
-%! assert(x, A\b, 1e-7*norm (x, Inf));
+%! assert (x, A\b, 1e-7*norm (x, Inf));
 
 %!test
 %! dim = 100;
@@ -571,7 +571,7 @@
 %! A = hilb (100);
 %! b = sum (A, 2);
 %! [x, flag, relres, iter] = gmres (A, b, [], 1e-14);
-%! assert(flag, 1);
+%! assert (flag, 1);
 
 %!test
 %! ## gmres recognizes that the preconditioner matrix is singular
@@ -637,7 +637,7 @@
 %!   y = A * x;
 %!endfunction
 %! [x, flag] = gmres ("Afun", [1; 2; 2; 3]);
-%! assert (x, ones(4, 1), 1e-6)
+%! assert (x, ones (4, 1), 1e-6)
 
 %!test # preconditioned residual
 %! A = toeplitz (sparse ([2, 1, 0, 0, 0]), sparse ([2, -1, 0, 0, 0]));
--- a/scripts/sparse/pcg.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/sparse/pcg.m	Tue Oct 13 18:17:29 2020 -0700
@@ -284,7 +284,7 @@
   b_norm = norm (b);
   if (b_norm == 0)
      if (n_arg_out < 2)
-       printf("The right hand side vector is all zero so pcg \n");
+       printf ("The right hand side vector is all zero so pcg \n");
        printf ("returned an all zero solution without iterating.\n");
      endif
      x_min = b;
--- a/scripts/sparse/pcr.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/sparse/pcr.m	Tue Oct 13 18:17:29 2020 -0700
@@ -334,7 +334,7 @@
 %! printf ("The solution relative error is %g\n", norm (x-X) / norm (X));
 %! clf;
 %! title ("Convergence history");
-%! xlabel ("Iteration"); ylabel ("log(||b-Ax||/||b||)");
+%! xlabel ("Iteration"); ylabel ("log (||b-Ax||/||b||)");
 %! semilogy ([0:iter], resvec/resvec(1), "o-g;relative residual;");
 
 %!demo
@@ -354,13 +354,13 @@
 %! endif
 %! clf;
 %! title ("Convergence history");
-%! xlabel ("Iteration"); ylabel ("log(||b-Ax||)");
+%! xlabel ("Iteration"); ylabel ("log (||b-Ax||)");
 %! semilogy ([0:iter], resvec, "o-g;absolute residual;");
 
 %!demo
 %! ## Full output from PCR
 %! ## We use an indefinite matrix based on the 1-D Laplacian matrix for A,
-%! ## and here we have cond(A) = O(N^2)
+%! ## and here we have cond (A) = O(N^2)
 %! ## That's the reason we need some preconditioner; here we take
 %! ## a very simple and not powerful Jacobi preconditioner,
 %! ## which is the diagonal of A.
@@ -383,7 +383,7 @@
 %! [x, flag, relres, iter, resvec] = pcr (A,b,[],maxit);
 %! clf;
 %! title ("Convergence history");
-%! xlabel ("Iteration"); ylabel ("log(||b-Ax||)");
+%! xlabel ("Iteration"); ylabel ("log (||b-Ax||)");
 %! semilogy ([0:iter], resvec, "o-g;NO preconditioning: absolute residual;");
 %!
 %! pause (1);
@@ -445,7 +445,7 @@
 %! b = ones (N,1);
 %! X = A \ b;  # X is the true solution
 %! [x, flag, relres, iter] = pcr (A,b,[],[],A,b);
-%! assert (norm (x-X) / norm(X) < 1e-6);
+%! assert (norm (x-X) / norm (X) < 1e-6);
 %! assert (relres < 1e-6);
 %! assert (flag, 0);
 %! assert (iter, 1); # should converge in one iteration
--- a/scripts/sparse/private/__alltohandles__.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/sparse/private/__alltohandles__.m	Tue Oct 13 18:17:29 2020 -0700
@@ -65,7 +65,7 @@
   elseif (ischar (A))
     Afun = str2func (A);
   elseif (!isnumeric (A) || !issquare (A))
-    error([solver_name, ": A must be a square matrix or a function handle"])
+    error ([solver_name, ": A must be a square matrix or a function handle"])
   else
     A_is_numeric = true;
     if (size (A, 2) != size (b, 1))
@@ -91,7 +91,7 @@
     elseif (ischar (M1))
       M1fun = str2func (M1);
     elseif (!isnumeric (M1) || !issquare (M1))
-      error([solver_name, ": M1 must be a square matrix or a function handle"])
+      error ([solver_name, ": M1 must be a square matrix or a function handle"])
     else
       M1_is_numeric = true;
     endif
@@ -114,7 +114,7 @@
     elseif (ischar (M2))
       M2fun = str2func (M2);
     elseif (!isnumeric (M2) || !issquare (M2))
-      error([solver_name, ": M2 must be a square matrix or a function handle"])
+      error ([solver_name, ": M2 must be a square matrix or a function handle"])
     else
       M2_is_numeric = true;
     endif
--- a/scripts/sparse/private/__sprand__.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/sparse/private/__sprand__.m	Tue Oct 13 18:17:29 2020 -0700
@@ -117,7 +117,7 @@
       else
         ## Only the min (m, n) greater singular values from rc vector are used.
         if (length (rc) > min (m,n))
-          rc = rc(1:min(m, n));
+          rc = rc(1:min (m, n));
         endif
         S = sparse (diag (sort (rc, "descend"), m, n));
       endif
--- a/scripts/sparse/qmr.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/sparse/qmr.m	Tue Oct 13 18:17:29 2020 -0700
@@ -206,13 +206,13 @@
       vt = pt - beta1 * v;
 
       y = M1m1x (vt);
-      rho1 = norm(y);
+      rho1 = norm (y);
       wt = Atx (q) - beta1 * w;
       z = M2tm1x (wt);
 
-      xi1 = norm(z);
-      theta1 = rho1 / (gamma0 * abs(beta1));
-      gamma1 = 1 / sqrt(1 + theta1^2);   # If gamma1 == 0, method fails.
+      xi1 = norm (z);
+      theta1 = rho1 / (gamma0 * abs (beta1));
+      gamma1 = 1 / sqrt (1 + theta1^2);   # If gamma1 == 0, method fails.
       eta1 = -eta0 * rho0 * gamma1^2 / (beta1 * gamma0^2);
 
       if (iter == 1)
@@ -267,7 +267,7 @@
       printf ("to a solution with relative residual %e\n", res1);
     endif
   else
-    print_usage();
+    print_usage ();
   endif
 
 endfunction
--- a/scripts/sparse/tfqmr.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/sparse/tfqmr.m	Tue Oct 13 18:17:29 2020 -0700
@@ -217,7 +217,7 @@
   norm_b = norm (b, 2);
   if (norm_b == 0)
     if (nargout < 2)
-      printf("The right hand side vector is all zero so tfqmr \n")
+      printf ("The right hand side vector is all zero so tfqmr \n")
       printf ("returned an all zero solution without iterating.\n")
     endif
     x_min = zeros (numel (b), 1);
@@ -242,7 +242,7 @@
   it = 1;
 
   try
-    warning("error", "Octave:singular-matrix", "local");
+    warning ("error", "Octave:singular-matrix", "local");
     u_hat = feval (M1fun, u, varargin{:});
     u_hat = feval (M2fun, u_hat, varargin{:});
     v = feval (Afun, u_hat, varargin{:});
@@ -306,8 +306,8 @@
   resvec = resvec (1: (iter + 1));
 
   relres = resvec (iter_min + 1) / norm (b);
-  iter_min = floor(iter_min / 2); # compatibility, since it
-                                  # makes two times the effective iterations
+  iter_min = floor (iter_min / 2); # compatibility, since it
+                                   # makes two times the effective iterations
 
   if (relres <= tol)
     flag = 0;
@@ -456,11 +456,11 @@
 
 %!test
 %!function y = Afun (x)
-%!   A = toeplitz ([2, 1, 0, 0], [2, -1, 0, 0]);
-%!   y = A * x;
+%!  A = toeplitz ([2, 1, 0, 0], [2, -1, 0, 0]);
+%!  y = A * x;
 %!endfunction
 %! [x, flag] = tfqmr ("Afun", [1; 2; 2; 3]);
-%! assert (x, ones(4, 1), 1e-6)
+%! assert (x, ones (4, 1), 1e-6)
 
 %!test # unpreconditioned residual
 %! A = toeplitz (sparse ([2, 1, 0, 0, 0]), sparse ([2, -1, 0, 0, 0]));
--- a/scripts/specfun/betaincinv.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/specfun/betaincinv.m	Tue Oct 13 18:17:29 2020 -0700
@@ -227,7 +227,7 @@
 function x = newton_method (F, JF, x0, a, b, y, tol, maxit);
   l = numel (y);
   res = -F (x0, a, b, y) ./ JF (x0, a, b);
-  todo = (abs(res) >= tol * abs (x0));
+  todo = (abs (res) >= tol * abs (x0));
   x = x0;
   it = 0;
   while (any (todo) && (it < maxit))
@@ -235,7 +235,7 @@
     x(todo) += res(todo);
     res(todo) = -F(x(todo), a(todo), b(todo), y(todo)) ...
                 ./ JF (x(todo), a(todo), b(todo));
-    todo = (abs(res) >= tol * abs (x));
+    todo = (abs (res) >= tol * abs (x));
   endwhile
   x += res;
 endfunction
--- a/scripts/specfun/cosint.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/specfun/cosint.m	Tue Oct 13 18:17:29 2020 -0700
@@ -140,7 +140,7 @@
   ssum = - xx .^ 2 / 4; # First term of the series expansion
   ## FIXME: This is way more precision than a double value can hold.
   gma = 0.57721566490153286060651209008; # Euler gamma constant
-  yy = gma + log (complex (xx)) + ssum;  # log(complex(...) handles signed zero
+  yy = gma + log (complex (xx)) + ssum;  # log (complex (...) handles signed zero
   flag_sum = true (nnz (todo), 1);
   it = 0;
   maxit = 300;
--- a/scripts/specfun/gammainc.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/specfun/gammainc.m	Tue Oct 13 18:17:29 2020 -0700
@@ -430,7 +430,7 @@
   endif
 
   ii = (x < 0) & (a == fix (a));
-  if (any(ii))  # remove spurious imaginary part.
+  if (any (ii))  # remove spurious imaginary part.
     y(ii) = real (y(ii));
   endif
 
--- a/scripts/statistics/discrete_cdf.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/statistics/discrete_cdf.m	Tue Oct 13 18:17:29 2020 -0700
@@ -64,7 +64,7 @@
 %!shared x,v,p,y
 %! x = [-1 0.1 1.1 1.9 3];
 %! v = 0.1:0.2:1.9;
-%! p = 1/length(v) * ones (1, length(v));
+%! p = 1/length (v) * ones (1, length (v));
 %! y = [0 0.1 0.6 1 1];
 %!assert (discrete_cdf ([x, NaN], v, p), [y, NaN], eps)
 
--- a/scripts/statistics/discrete_inv.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/statistics/discrete_inv.m	Tue Oct 13 18:17:29 2020 -0700
@@ -76,7 +76,7 @@
 %!shared x,v,p,y
 %! x = [-1 0 0.1 0.5 1 2];
 %! v = 0.1:0.2:1.9;
-%! p = 1/length(v) * ones (1, length(v));
+%! p = 1/length (v) * ones (1, length (v));
 %! y = [NaN v(1) v(1) v(end/2) v(end) NaN];
 %!assert (discrete_inv ([x, NaN], v, p), [y, NaN], eps)
 
--- a/scripts/statistics/discrete_rnd.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/statistics/discrete_rnd.m	Tue Oct 13 18:17:29 2020 -0700
@@ -88,7 +88,7 @@
 %!assert (class (discrete_rnd (1:2, 1:2)), "double")
 %!assert (class (discrete_rnd (single (1:2), 1:2)), "single")
 ## FIXME: Maybe this should work, maybe it shouldn't.
-#%!assert(class (discrete_rnd (1:2, single(1:2))), "single")
+#%!assert (class (discrete_rnd (1:2, single(1:2))), "single")
 
 ## Test input validation
 %!error <Invalid call> discrete_rnd ()
--- a/scripts/strings/base2dec.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/strings/base2dec.m	Tue Oct 13 18:17:29 2020 -0700
@@ -115,7 +115,7 @@
 
   ## Multiply the resulting digits by the appropriate power
   ## and sum the rows.
-  out = s * (base .^ (columns(s)-1 : -1 : 0)');
+  out = s * (base .^ (columns (s)-1 : -1 : 0)');
 
 endfunction
 
--- a/scripts/strings/strtok.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/strings/strtok.m	Tue Oct 13 18:17:29 2020 -0700
@@ -137,7 +137,7 @@
     if (isargout (2))
       rem = cell (size (str));
       rem(eidx) = {""};
-      rem(midx) = tmp(2:2:end);
+      rem (midx) = tmp(2:2:end);
     endif
   endif
 
--- a/scripts/testfun/private/compare_plot_demos.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/testfun/private/compare_plot_demos.m	Tue Oct 13 18:17:29 2020 -0700
@@ -57,7 +57,7 @@
   arg.fcn_file = "dump_plot_demos.m";
   arg.replace_images = false;
 
-  for n = 1:2:numel(varargin)
+  for n = 1:2:numel (varargin)
     if (! ischar (varargin{n}))
       print_usage ();
     else
--- a/scripts/testfun/private/html_compare_plot_demos.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/testfun/private/html_compare_plot_demos.m	Tue Oct 13 18:17:29 2020 -0700
@@ -70,12 +70,12 @@
   in.plots_per_page = 50;
 
   ## Parse inputs
-  for n = 1:2:numel(varargin)
+  for n = 1:2:numel (varargin)
     in.(lower(varargin{n})) = varargin{n+1};
   endfor
 
   ## Compile a list of all files for all toolkits
-  for t = 1:numel(toolkits)
+  for t = 1:numel (toolkits)
     filter = sprintf ("%s/*.%s", toolkits{t}, in.fmt);
     in.figfiles = union (in.figfiles, {dir(filter).name});
   endfor
@@ -87,7 +87,7 @@
   anchor = "<!-- ##ADD TABLE HERE## -->";
   n = strfind (template, anchor);
   header = strtrim (template(1:n-1));
-  trailer = strtrim (template(n+numel(anchor):end));
+  trailer = strtrim (template(n+numel (anchor):end));
 
   page = 1;
   do
@@ -123,7 +123,7 @@
 
       ## Create table header
       fprintf (fid, "<table>\n<tr>\n");
-      for t = 1:numel(toolkits)
+      for t = 1:numel (toolkits)
         ## set default
         column_header = upper (toolkits{t});
         if (isfield (in, toolkits{t}))
@@ -147,7 +147,7 @@
           else
             err_fn = strrep (ffn, ".png", ".err");
             if (! exist (err_fn, "file"))
-              warning("File %s doesn't exist...", err_fn);
+              warning ("File %s doesn't exist...", err_fn);
             else
               err_fid = fopen (err_fn);
               msg = char (fread (err_fid))';
--- a/scripts/testfun/speed.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/testfun/speed.m	Tue Oct 13 18:17:29 2020 -0700
@@ -243,7 +243,7 @@
         __t = min ([__t, __t2, __t3]);
       endif
       __torig(k) = __t;
-      if (! isinf(__tol))
+      if (! isinf (__tol))
         assert (__v1, __v2, __tol);
       endif
     endif
@@ -403,7 +403,7 @@
 %! fstr_build = cstrcat (
 %!   "function x = build (n)\n",
 %!   "  idx = [1:100]';\n",
-%!   "  x = idx(:,ones(1,n));\n",
+%!   "  x = idx(:,ones (1,n));\n",
 %!   "  x = reshape (x, 1, n*100);\n",
 %!   "endfunction");
 %!
--- a/scripts/testfun/test.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/testfun/test.m	Tue Oct 13 18:17:29 2020 -0700
@@ -669,7 +669,7 @@
       endif
 
       ## evaluate code for test, shared, and assert.
-      if (! isempty(__code))
+      if (! isempty (__code))
         try
           eval (sprintf ("function %s__test__(%s)\n%s\nendfunction",
                          __shared_r, __shared, __code));
@@ -726,7 +726,7 @@
             && ! strcmp (__type, "xtest")
             && ! all (__shared == " "))
           fputs (__fid, "shared variables ");
-          eval (sprintf ("fdisp(__fid,var2struct(%s));", __shared));
+          eval (sprintf ("fdisp (__fid,var2struct(%s));", __shared));
         endif
         fflush (__fid);
       endif
@@ -914,7 +914,7 @@
 function msg = trimerr (msg, prefix)
   idx = index (msg, [prefix ":"]);
   if (idx > 0)
-    msg(1:idx+length(prefix)) = [];
+    msg(1:idx+length (prefix)) = [];
   endif
   msg = strtrim (msg);
 endfunction
@@ -1079,15 +1079,15 @@
 ## All of the following tests should fail.  These tests should
 ## be disabled unless you are developing test() since users don't
 ## like to be presented with known failures.
-## %!test   error("---------Failure tests.  Use test('test','verbose',1)");
-## %!test   assert([a,b,c],[1,3,6]);   # variables have wrong values
+## %!test   error ("---------Failure tests.  Use test('test','verbose',1)");
+## %!test   assert ([a,b,c],[1,3,6]);   # variables have wrong values
 ## %!invalid                   # unknown block type
-## %!error  toeplitz([1,2,3]); # correct usage
+## %!error  toeplitz ([1,2,3]); # correct usage
 ## %!test   syntax errors)     # syntax errors fail properly
 ## %!shared garbage in         # variables must be comma separated
 ## %!error  syntax++error      # error test fails on syntax errors
 ## %!error  "succeeds.";       # error test fails if code succeeds
-## %!error <wrong pattern> error("message")  # error pattern must match
+## %!error <wrong pattern> error ("message")  # error pattern must match
 ## %!demo   with syntax error  # syntax errors in demo fail properly
 ## %!shared a,b,c
 ## %!demo                      # shared variables not available in demo
--- a/scripts/web/weboptions.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/web/weboptions.m	Tue Oct 13 18:17:29 2020 -0700
@@ -264,7 +264,7 @@
 
     function f = set.Timeout (f, value)
       if (! isreal (value) || ! isscalar (value)
-          || floor(value) != value || value < 0)
+          || floor (value) != value || value < 0)
         error ("weboptions: invalid Timeout value");
       else
         f.Timeout = value;
--- a/scripts/web/webread.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/web/webread.m	Tue Oct 13 18:17:29 2020 -0700
@@ -48,7 +48,7 @@
 function response = webread (url, varargin)
 
   if (nargin == 0)
-    print_usage();
+    print_usage ();
   endif
 
   if (! (ischar (url) && isrow (url)))
--- a/scripts/web/webwrite.m	Tue Oct 13 15:31:11 2020 -0700
+++ b/scripts/web/webwrite.m	Tue Oct 13 18:17:29 2020 -0700
@@ -47,7 +47,7 @@
 function response = webwrite (url, varargin)
 
   if (nargin < 2)
-    print_usage();
+    print_usage ();
   endif
 
   if (! (ischar (url) && isrow (url)))