octave_src


  1. advection_pde, an Octave code which solves the advection partial differential equation (PDE) dudt + c * dudx = 0 in one spatial dimension, with a constant velocity c, and periodic boundary conditions, using the FTCS method, forward time difference, centered space difference.
  2. advection_pde_test
  3. allen_cahn_pde, an Octave code which sets up and solves the Allen-Cahn reaction-diffusion partial differential equation (PDE) in 1 space dimension and time.
  4. allen_cahn_pde_test
  5. alpert_rule, an Octave code which sets up an Alpert quadrature rule for functions which are regular, log(x) singular, or 1/sqrt(x) singular.
  6. alpert_rule_test
  7. analemma, an Octave code which evaluates the equation of time, a formula for the difference between the uniform 24 hour day and the actual position of the sun, based on a C program by Brian Tung.
  8. analemma_test
  9. anishchenko_ode, an Octave code which sets up and solves the Anishchenko ordinary differential equation (ODE), which has chaotic behavior and an attractor.
  10. anishchenko_ode_test
  11. annulus_distance, an Octave code which estimates the typical distance between a pair of points randomly selected inside a circular annulus.
  12. annulus_distance_test
  13. annulus_grid, an Octave code which computes a grid of points over the interior of a circular annulus.
  14. annulus_grid_test
  15. annulus_integrals, an Octave code which returns the exact value of the integral of any monomial over the interior of an annulus centered at the origin.
  16. annulus_integrals_test
  17. annulus_monte_carlo, an Octave code which uses the Monte Carlo method to estimate the integral of a function over the interior of a circular annulus in 2D.
  18. annulus_monte_carlo_test
  19. annulus_rule, an Octave code which computes a quadrature rule for estimating integrals of a function over the interior of a circular annulus in 2D.
  20. annulus_rule_test
  21. approx_bernstein, an Octave code which interactively approximates a function f(x) in the interval [a,b] by constructing a Bernstein polynomial.
  22. approx_bernstein_test
  23. approx_chebyshev, an Octave code which interactively approximates a function f(x) in the interval [a,b] by constructing a Chebyshev polynomial interpolant that is often a good estimate of the minimax polynomial.
  24. approx_chebyshev_test
  25. approx_leastsquares, an Octave code which interactively approximates a function f(x) in the interval [a,b] by constructing an m-degree polynomial which minimizes the square root of the sum of the squares of the error with n sample data points.
  26. approx_leastsquares_test
  27. arclength, an Octave code which estimates the arclength of curves of the form (x,f(x)) or (x(t),y(t)).
  28. arclength_test
  29. arenstorf_ode, an Octave code which sets up and solves an ordinary differential equation (ODE) which defines a stable periodic orbit of a spacecraft around the Earth and the Moon.
  30. arenstorf_ode_test
  31. args, an Octave code which shows how to count and report command line arguments;
  32. args_test
  33. arneodo_ode, an Octave code which sets up and solves the Arneodo ordinary differential equation (ODE), which has chaotic behavior and an attractor.
  34. arneodo_ode_test
  35. artery_pde, an Octave code which solves a partial differential equation (PDE) in one spatial dimension and time, that models the displacement of arterial walls under pressure.
  36. artery_pde_test
  37. asa_2011_geometry, an Octave code which was used during labs, demonstrations, and lectures associated with the Geometry Algorithms portion of the class Algorithms for Science Applications II, as taught at the Scientific Computing Department, Florida State University, Spring Semester 2011.
  38. asa_2011_geometry_test
  39. asa_2011_graphs, a MATLAB code which was used during labs, demonstrations, and lectures associated with the Graph Algorithms portion of the class Algorithms for Science Applications II, as taught at the Scientific Computing Department, Florida State University, Spring Semester 2011.
  40. asa_2011_images, an Octave code which was used during labs, demonstrations, and lectures associated with the Image Algorithms portion of the class Algorithms for Science Applications II, as taught at the Scientific Computing Department, Florida State University, Spring Semester 2011.
  41. asa005, an Octave code which evaluates the Cumulative Density Function (CDF) of the noncentral T Probability Density Function (PDF), by BE Cooper. This is a version of Applied Statistics Algorithm 5;
  42. asa005_test
  43. asa006, an Octave code which computes the Cholesky factorization of a symmetric positive definite (SPD) matrix, by Michael Healy. This is a version of Applied Statistics Algorithm 6;
  44. asa006_test
  45. asa007, an Octave code which computes the inverse of a symmetric positive definite (SPD) matrix, by Michael Healy. This is a version of Applied Statistics Algorithm 7.
  46. asa007_test
  47. asa032, an Octave code which evaluates the incomplete Gamma function, by G Bhattacharjee. This is a version of Applied Statistics Algorithm 32.
  48. asa032_test
  49. asa047, an Octave code which minimizes a scalar function of several variables using the Nelder-Mead algorithm, by R ONeill. This is a version of Applied Statistics Algorithm 47.
  50. asa047_test
  51. asa053, an Octave code which produces sample matrices from the Wishart distribution, by William Smith and Ronald Hocking. This is a version of Applied Statistics Algorithm 53.
  52. asa053_test
  53. asa058, an Octave code which implements the K-means data clustering algorithm, by David Sparks. This is a version of Applied Statistics Algorithm 58.
  54. asa058_test
  55. asa063, an Octave code which evaluates the incomplete Beta function, by KL Majumder and G Bhattacharjee. This is a version of Applied Statistics Algorithm 63.
  56. asa063_test
  57. asa066, an Octave code which evaluates the Cumulative Density Function (CDF) of the normal probability distribution, by David Hill. This is a version of Applied Statistics Algorithm 66.
  58. asa066_test
  59. asa076, an Octave code which evaluates the Owen T function, needed to compute the Cumulative Density Function (CDF) of the noncentral T distribution, by Young and Minder. This is a version of Applied Statistics Algorithm 76.
  60. asa076_test
  61. asa082, an Octave code which computes the determinant of an orthogonal matrix; this is a version of Applied Statistics Algorithm 82, by J C Gower.
  62. asa082_test
  63. asa091, an Octave code which evaluates the percentage points of the Chi-Squared distribution, by Best and Roberts. This is a version of Applied Statistics Algorithm 91.
  64. asa091_test
  65. asa103, an Octave code which evaluates the digamma or psi function, by Jose Bernardo. This is a version of Applied Statistics Algorithm 103.
  66. asa103_test
  67. asa109, an Octave code which inverts the incomplete Beta function, by Cran, Martin and Thomas. This is a version of Applied Statistics Algorithm 109.
  68. asa109_test
  69. asa111, an Octave code which evaluates the percentage points of the normal distribution, by Beasley and Springer. This is a version of Applied Statistics Algorithm 111.
  70. asa111_test
  71. asa113, an Octave code which implements a clustering algorithm using transfers and swaps, by Banfield and Bassill. This is a version of Applied Statistics Algorithm 113.
  72. asa113_test
  73. asa121, an Octave code which evaluates the trigamma function, by BE Schneider. This is a version of Applied Statistics Algorithm 121.
  74. asa121_test
  75. asa136, an Octave code which implements a clustering algorithm, by Hartigan and Wong. This is a version of Applied Statistics Algorithm 136.
  76. asa136_test
  77. asa144, an Octave code which randomly generates an RxC contingency table, by James Boyett. This is a version of Applied Statistics Algorithm 144.
  78. asa144_test
  79. asa147, an Octave code which evaluates the incomplete Gamma function, by Chi Leung Lau. This is a version of Applied Statistics Algorithm 147.
  80. asa147_test
  81. asa152, an Octave code which evaluates the Probability Density Function (PDF) and Cumulative Density Function (CDF) associated with the hypergeometric distribution, by Richard Lund; this is a version of Applied Statistics Algorithm 152.
  82. asa152_test
  83. asa159, an Octave code which randomly generates an RxC contingency table, by Michael Patefield; This is a version of Applied Statistics Algorithm 159.
  84. asa159_test
  85. asa172, an Octave code which generates all M-dimensional indices in a given range, simulating the behavior of an arbitrary number of nested loops, by OFlaherty and MacKenzie. this is a version of Applied Statistics Algorithm 172;
  86. asa172_test
  87. asa183, an Octave code which implements a random number generator (RNG), by Wichman and Hill. This is a version of Applied Statistics Algorithm 183.
  88. asa183_test
  89. asa226, an Octave code which evaluates the Cumulative Density Function (CDF) of the noncentral Beta distribution, by Russell Lenth. This is a version of Applied Statistics Algorithm 226.
  90. asa226_test
  91. asa239, an Octave code which evaluates the incomplete Gamma function, by Shea. This is a version of Applied Statistics Algorithm 239.
  92. asa239_test
  93. asa241, an Octave code which evaluates the percentage points of the normal distribution, by Michael Wichura. This is a version of Applied Statistics Algorithm 241.
  94. asa241_test
  95. asa243, an Octave code which evaluates the Cumulative Density Function (CDF) of the noncentral T distribution, by Russell Lenth; this is a version of Applied Statistics Algorithm 243.
  96. asa243_test
  97. asa245, an Octave code which evaluates the logarithm of the Gamma function, by Allan Mcleod; this is a version of Applied Statistics Algorithm 245.
  98. asa245_test
  99. asa266, an Octave code which evaluates various properties of the Dirichlet Probability Density Function (PDF); This is a version of Applied Statistics Algorithm 266.
  100. asa266_test
  101. asa299, an Octave code which computes the lattice points in an M-dimensional simplex, by Chasalow and Brand; this is a version of Applied Statistics Algorithm 299;
  102. asa299_test
  103. asa310, an Octave code which computes the Cumulative Density Function (CDF) of the noncentral Beta distribution, by Chattamvelli and Shanmugam; this is a version of Applied Statistics Algorithm 310.
  104. asa310_test
  105. asa314, an Octave code which computes the inverse of a matrix whose elements are subject to modulo arithmetic, by Roger Payne. This is a version of Applied Statistics Algorithm 314;
  106. asa314_test
  107. atbash, an Octave code which applies the Atbash substitution cipher to a string of text.
  108. atbash_test
  109. atkinson, an Octave code which contains examples from the text 'Elementary Numerical Analysis', by Atkinson.
  110. atkinson_test
  111. autocatalytic_ode, an Octave code which sets up and solves the autocatalytic ordinary differential equation (ODE), which has chaotic behavior and an attractor.
  112. autocatalytic_ode_test
  113. axon_ode, an Octave code which sets up and solves the ordinary differential equations (ODE) for the Hodgkin-Huxley model of an axon.
  114. axon_ode_test
  115. backtrack_binary_rc, an Octave code which carries out a backtrack search for a set of binary decisions, using reverse communication (RC).
  116. backtrack_binary_rc_test
  117. backward_euler, an Octave code which solves one or more ordinary differential equations (ODE) using the (implicit) backward Euler method, using fsolve() for the implicit equation.
  118. backward_euler_test
  119. backward_euler_fixed, an Octave code which solves one or more ordinary differential equations (ODE) using the (implicit) backward Euler method, using a fixed point iteration for the implicit equation.
  120. backward_euler_fixed_test
  121. ball_distance, an Octave code which computes the expected value of the distance between a pair of points randomly selected from the interior of the unit ball in 3D.
  122. ball_distance_test
  123. ball_grid, an Octave code which computes a grid of points over the interior of the unit ball in 3D.
  124. ball_grid_test
  125. ball_integrals, an Octave code which returns the exact value of the integral of any monomial over the interior of the unit ball in 3D.
  126. ball_integrals_test
  127. ball_monte_carlo, an Octave code which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit ball in 3D;
  128. ball_monte_carlo_test
  129. ball_positive_distance, an Octave code which computes the expected value of the distance between a pair of points randomly selected from the interior of the unit positive ball in 3D.
  130. ball_positive_distance_test
  131. bank, an Octave code which computes the check digit associated with a US Bank Routing Number check digit, or reports whether a 9-digit code is actually valid.
  132. bank_test
  133. barycentric_interp_1d, an Octave code which defines and evaluates the barycentric Lagrange polynomial p(x) which interpolates a set of data, so that p(x(i)) = y(i). The barycentric approach means that very high degree polynomials can safely be used.
  134. barycentric_interp_1d_test
  135. bdf2, an Octave code which solves one or more ordinary differential equations (ODE) using BDF2, the (implicit) backward difference formula of order 2, using fsolve() to solve the implicit equation.
  136. bdf2_test
  137. bellman_ford, an Octave code which implements the Bellman-Ford algorithm for finding the shortest distance from a given node to all other nodes in a directed graph whose edges have been assigned real-valued lengths.
  138. bellman_ford_test
  139. bernstein_approximation, an Octave code which looks at some simple cases of approximation of a function f(x) by a Bernstein polynomial.
  140. bernstein_approximation_test
  141. bernstein_polynomial, an Octave code which evaluates the Bernstein polynomials;
  142. bernstein_polynomial_test
  143. besselj, an Octave code which evaluates Bessel J functions of noninteger order;
  144. besselj_test
  145. besselzero, an Octave code which computes the zeros of Bessel functions j or y, by Greg van Winckel and Jason Nicholson.
  146. besselzero_test
  147. beta_nc, an Octave code which evaluates the cumulative density function (CDF) of the noncentral Beta distribution;
  148. beta_nc_test
  149. bezier_surface, an Octave code which reads, writes, prints and manipulates the data that defines a Bezier surface;
  150. bezier_surface_test
  151. bezier_surface_display, an Octave code which displays a Bezier surface;
  152. bezier_surface_display_test
  153. bicg, an Octave code which implements the biconjugate gradient method (BICG), which estimates the solution of a large sparse nonsymmetric linear system.
  154. bicg_test
  155. biharmonic_cheby1d, an Octave code which uses Chebyshev methods to solve the biharmonic equation over an interval, a fourth order two point boundary value problem (BVP) in one spatial dimension.
  156. biharmonic_cheby1d_test
  157. biharmonic_fd1d, an Octave code which applies the finite difference method to solve the biharmonic equation over an interval, a fourth order two point boundary value problem (BVP) in one spatial dimension.
  158. biharmonic_fd1d_test
  159. biharmonic_fd2d, an Octave code which deals with the biharmonic equation in two dimensions, whose simplest form is uxxxx + 2uxxyy + uyyyy = f.
  160. biharmonic_fd2d_test
  161. biochemical_linear_ode, an Octave code which sets up and solves a linear biochemical ordinary differential equation (ODE).
  162. biochemical_linear_ode_test
  163. biochemical_nonlinear_ode, an Octave code which sets up and solves a nonlinear biochemical ordinary differential equation (ODE).
  164. biochemical_nonlinear_ode_test
  165. bioconvection_ode, an Octave code which approximates solutions to a system of ordinary differential equations (ODE) which model a bioconvection problem, and which are related to the Lorenz system.
  166. bioconvection_ode_test
  167. bird_egg, an Octave code which evaluates some formulas for the shapes of bird eggs.
  168. bird_egg_test
  169. bisection, an Octave code which applies the bisection method to seek a root of f(x) over a change-of-sign interval a <= x <= b.
  170. bisection_test
  171. bisection_integer, an Octave code which seeks an integer solution to the equation F(X)=0, using bisection within a user-supplied change of sign interval [a,b].
  172. bisection_integer_test
  173. bisection_rc, an Octave code which seeks a solution to the equation F(X)=0 using bisection within a user-supplied change of sign interval [a,b]. The procedure is written using reverse communication (RC).
  174. bisection_rc_test
  175. black_scholes, an Octave code which implements some simple approaches to the Black-Scholes option valuation theory, by Desmond Higham.
  176. black_scholes_test
  177. blend, an Octave code which carries out 1D/2D/3D blending interpolation;
  178. blend_test
  179. blood_pressure_ode, an Octave code which sets up and solves an ordinary differential equation (ODE) which models the variation in blood pressure in the human artery.
  180. blood_pressure_ode_test
  181. blowup_ode, an Octave code which sets up and solves an ordinary differential equation (ODE) y'=y^2. whose solution "blows up" in finite time.
  182. blowup_ode_test
  183. boat, an Octave code which considers the boat tiling puzzle, a smaller version of the eternity puzzle. The boat puzzle specifies a region R composed of 756 30-60-90 triangles, and a set of 21 "tiles", each consisting of 36 30-60-90 triangles, and seeks an arrangement of the tiles that exactly covers the region.
  184. boat_test
  185. boat_cplex_test a BASH code which calls cplex(), to read the LP file defining the boat tiling problem, solve the linear programming problem, and write the solution to a file.
  186. boat_gurobi_test a BASH code which calls gurobi(), to read the LP file defining the boat tiling problem, solve the linear programming problem, and write the solution to a file.
  187. boundary_locus, an Octave code which uses the boundary locus method to display the region of absolute stability for a solver of ordinary differential equations (ODE).
  188. boundary_locus_test
  189. boundary_locus2, an Octave code which uses the boundary locus method to plot the boundary of the absolute stability region for a solver of ordinary differential equations (ODE), based on a procedure by Randall Leveque.
  190. boundary_locus2_test
  191. boundary_word_drafter, an Octave code which describes the outline of an object using a string of symbols that represent the sequence of steps tracing out the boundary, on a grid of drafters, or 30-60-90 triangles. The objects include tiles for the eternity, serenity and trinity puzzles, and the hat and turtle aperiodic monotiles.
  192. boundary_word_drafter_test
  193. boundary_word_equilateral, an Octave code which describes the outline of an object on a grid of equilateral triangles, using a string of symbols that represent the sequence of steps tracing out the boundary.
  194. boundary_word_equilateral_test
  195. boundary_word_hexagon, an Octave code which describes the outline of an object on a grid of hexagons, using a string of symbols that represent the sequence of steps tracing out the boundary.
  196. boundary_word_hexagon_test
  197. boundary_word_right, an Octave code which describes the outline of an object on a grid of isoceles right triangles, using a string of symbols that represent the sequence of steps tracing out the boundary.
  198. boundary_word_right_test
  199. boundary_word_square, an Octave code which describes the outline of an object on a grid of squares, using a string of symbols that represent the sequence of steps tracing out the boundary.
  200. boundary_word_square_test
  201. box_behnken, an Octave code which computes a Box-Behnken design, that is, a set of arguments to sample the behavior of a function of multiple parameters;
  202. box_behnken_test
  203. box_display, an Octave code which displays a box plot, over integer pairs of data, of a function defined by two formulas.
  204. box_display_test
  205. box_distance, an Octave code which estimates the distribution and expected value of the distance between two points picked uniformly at random within a box.
  206. box_distance_test
  207. box_games, an Octave code which assists in the display of game boards (checkers, cellular automatons, life);
  208. box_games_test
  209. box_plot, an Octave code which displays a box plot of data that consists of pairs of integers;
  210. box_plot_test
  211. brownian_motion_simulation, an Octave code which simulates Brownian motion in an M dimensional region.
  212. brownian_motion_simulation_test
  213. broyden, an Octave code which implements the Broyden iterative method for nonlinear equations, by Tim Kelley.
  214. broyden_test
  215. brusselator_ode, an Octave code which sets up and solves the Brusselator ordinary differential equation (ODE) system.
  216. brusselator_ode_test
  217. buckling_spring, an Octave code which plots solutions of the buckling spring equations.
  218. buckling_spring_test
  219. burgers_solution, an Octave code which evaluates exact solutions of the time-dependent 1D viscous Burgers equation.
  220. burgers_solution_test
  221. burgers_steady_viscous, an Octave code which solves the steady (time-independent) viscous Burgers equation using the finite difference method (FDM) applied to the conservative form of the equation, using the Newton method to solve the resulting nonlinear system.
  222. burgers_steady_viscous_test
  223. burgers_time_inviscid, an Octave code which solves the time-dependent inviscid Burgers equation using the finite difference method (FDM), and one of six solution methods.
  224. burgers_time_inviscid_test
  225. burgers_time_viscous, an Octave code which solves the time-dependent viscous Burgers equation using the finite difference method (FDM) applied to the conservative form of the equation.
  226. burgers_time_viscous_test
  227. bvec, an Octave code which demonstrates how signed integers can be stored as binary vectors, and arithmetic can be performed on them.
  228. bvec_test
  229. bvp_fd, an Octave code which demonstrates the use of the finite difference method (FDM) to solve a boundary value problem (BVP).
  230. bvp_fd_test
  231. bvp_shooting_test, an Octave code which demonstrates the use of the shooting method to solve a boundary value problem (BVP).
  232. c8lib, an Octave code which implements certain elementary functions for complex 64 bit ("C8") variables;
  233. c8lib_test
  234. caesar, an Octave code which applies a Caesar Shift Cipher to a string of text.
  235. caesar_test
  236. calpak, an Octave code which computes various simple calendrical quantities. It can work with various calendars including Egyptian, English, French Revolutionary, Gregorian, Julian, and Julian Ephemeris Date. It can convert a date from one calendar to another. It can return the day of the week for a given date. It can convert from day-number/year to day/month/year format. It can calculate the time difference between two dates.
  237. calpak_test
  238. capacitor_2d_test, an Octave code which plots data from a model of a 2D capacitor, computed by FreeFem++() and transferred using the ffmatlib() library.
  239. capacitor_3d_test, an Octave code which plots data from a model of a 3D capacitor, computed by FreeFem++() and transferred using the ffmatlib() library.
  240. casino_simulation, an Octave code which simulates a casino game that gives you 20% of your bet for heads, and only takes 17% for tails. How much will you end up winning?
  241. casino_simulation_test
  242. cauchy_method, an Octave code which solves one or more ordinary differential equations (ODE) using the Cauchy method.
  243. cauchy_method_test
  244. cauchy_principal_value, an Octave code which uses Gauss-Legendre quadrature to estimate the Cauchy Principal Value (CPV) of certain singular integrals.
  245. cauchy_principal_value_test
  246. caustic, an Octave code which generates an image of a caustic, by drawing n equally spaced points in a circle, and then connecting specific pairs of points using a spacing parameter m.
  247. caustic_test
  248. cavity_flow_display, an Octave code which displays a single velocity field solution for the driven cavity;
  249. cavity_flow_display_test
  250. cc_display, an Octave code which displays the points used in a 2D Clenshaw-Curtis quadrature rule;
  251. cc_display_test
  252. ccl_test, an Octave code which estimates the Lebesgue constants for sets of points in [-1,+1] computed in several ways. The program is probably of limited interest except as an example of an application of the lebesgue_constant() function.
  253. ccn_rule, an Octave code which defines a Clenshaw Curtis Nested (CCN) quadrature rule.
  254. ccn_rule_test
  255. ccs_io an Octave code which reads and writes sparse linear systems stored in the Compressed Column Storage (CCS) format.
  256. ccs_io_test
  257. ccs_to_st an Octave code which converts a sparse matrix from Compressed Column Storage (CCS) to sparse triplet (ST) format.
  258. ccs_to_st_test
  259. cellular_automaton, an Octave code which prints or plots the evolution of Cellular Automaton rule #30.
  260. cellular_automaton_test
  261. cg, an Octave code which implements a simple version of the conjugate gradient (CG) method for solving a system of linear equations of the form A*x=b, suitable for situations in which the matrix A is symmetric positive definite (SPD).
  262. cg_test
  263. cg_ne, an Octave code which implements the conjugate gradient method (CG) for the normal equations, where the matrix A is not symmetric positive definite (SPD). In this case, it is attempted to set up and solve the normal equations A'*A*x=A'*b.
  264. cg_ne_test
  265. cg_rc, an Octave code which implements the conjugate gradient (CG) method for solving a symmetric positive definite (SPD) sparse linear system A*x=b, using reverse communication (RC).
  266. cg_rc_test
  267. cg_squared, an Octave code which implements the conjugate gradient squared (CGS) method for solving a nonsymmetric sparse linear system A*x=b.
  268. cg_squared_test
  269. change_diophantine, an Octave code which sets up a Diophantine equation to solve the change making problem, which counts the number of ways a given sum can be formed using coins of various denominations.
  270. change_diophantine_test
  271. change_dynamic, an Octave code which uses dynamic programming to solve the change making problem, in which a given sum is to be formed using coins of various denominations.
  272. change_dynamic_test
  273. change_greedy, an Octave code which uses the greedy method to seek a solution to the change making problem, which tries to match a given amount by selecting coins of various denominations.
  274. change_greedy_test
  275. change_polynomial, an Octave code which uses a polynomial multiplication algorithm to count the ways of making various sums using a given number of coins.
  276. change_polynomial_test
  277. chebyshev, an Octave code which computes the Chebyshev interpolant/approximant to a given function over an interval.
  278. chebyshev_test
  279. chebyshev_interp_1d, an Octave code which determines the combination of Chebyshev polynomials which interpolates a set of data, so that p(x(i)) = y(i).
  280. chebyshev_interp_1d_test
  281. chebyshev_polynomial, an Octave code which considers the Chebyshev polynomials T(i,x), U(i,x), V(i,x) and W(i,x).
  282. chebyshev_polynomial_test
  283. chebyshev_series, an Octave code which evaluates a Chebyshev series approximating a function f(x), while efficiently computing one, two, three or four derivatives of the series, by Manfred Zimmer.
  284. chebyshev_series_test
  285. chebyshev1_exactness, an Octave code which tests the polynomial exactness of Gauss-Chebyshev type 1 quadrature rules.
  286. chebyshev1_exactness_test
  287. chebyshev1_rule, an Octave code which computes and writes out a Gauss-Chebyshev type 1 quadrature rule of given order.
  288. chebyshev1_rule_test
  289. chebyshev2_exactness, an Octave code which tests the polynomial exactness of Gauss-Chebyshev type 2 quadrature rules.
  290. chebyshev2_exactness_test
  291. chebyshev2_rule, an Octave code which computes and writes out a Gauss-Chebyshev type 2 quadrature rule of given order.
  292. chebyshev2_rule_test
  293. chen_ode, an Octave code which sets up and solves the Chen system of ordinary differential equations (ODE).
  294. chen_ode_test
  295. cheney_kincaid, an Octave code which contains examples from the text 'Numerical Mathematics and Computing', by Cheney and Kincaid.
  296. cheney_kincaid_test
  297. chinese_remainder_theorem, an Octave code which demonstrates the Chinese remainder theorem, for reconstructing a number based on its remainders against a set of bases.
  298. chinese_remainder_theorem_test
  299. chirikov_iteration, an Octave code which applies the Chirikov map repeatedly to a given (x,y) initial condition.
  300. chirikov_iteration_test
  301. chladni_figures, an Octave code which creates Chladni figures of the eigenmodes of a thin vibrating plate, by Martin Gander and Felix Kwok.
  302. chladni_figures_test
  303. chrpak, an Octave code which manipulates characters and strings;
  304. chrpak_test
  305. chuckaluck_simulation, an Octave code which simulates the Chuck-a-Luck gambling game.
  306. chuckaluck_simulation_test
  307. circle_arc_grid, an Octave code which computes grid points along a circular arc.
  308. circle_arc_grid_test
  309. circle_distance, an Octave code which computes the expected value of the distance between a pair of points randomly selected on the circumference of the unit circle in 2D.
  310. circle_distance_test
  311. circle_grid_display an Octave code which reads a matrix of integers, and draws a corresponding grid of circles filled with color.
  312. circle_grid_display_test
  313. circle_integrals, an Octave code which returns the exact value of the integral of any monomial over the circumference of the unit circle in 2D.
  314. circle_integrals_test
  315. circle_map, an Octave code which illustrates how a matrix maps points on the unit circle to an ellipse.
  316. circle_map_test
  317. circle_monte_carlo, an Octave code which applies a Monte Carlo method to estimate the integral of a function along the circumference of the unit circle in 2D;
  318. circle_monte_carlo_test
  319. circle_positive_distance, an Octave code which estimates the mean and variance of the distance between a random pair of points on the circumference of the unit positive circle in 2D.
  320. circle_positive_distance_test
  321. circle_rule, an Octave code which computes quadrature rules for the unit circle in 2D, to approximate integrals of f(x,y) over the circumference of the circle of radius 1 and center (0,0).
  322. circle_rule_test
  323. circle_segment, an Octave code which carries out computations associated with a circle segment, including height, angle, area, centroid, sampling, and quadrature.
  324. circle_segment_test
  325. circles, an Octave code which draws one or more circles, while controlling the center locations, radii, colors, edge colors, and transparency, by Chad Greene.
  326. circles_test
  327. cities, an Octave code which works with city-to-city distance matrices;
  328. cities_test
  329. clausen, an Octave code which evaluates a Chebyshev interpolant to the Clausen function Cl2(x).
  330. clausen_test
  331. clenshaw_curtis_rule, an Octave code which implements a Clenshaw Curtis quadrature rule;
  332. clenshaw_curtis_rule_test
  333. clock_solitaire_simulation, an Octave code which simulates the game of clock solitaire. The deck is dealt into 13 piles of 4 cards each. Repeatedly, the top card a pile is removed, and its rank indicates the next pile to consider. Game continues until an empty pile is reached. The game is won if all piles are empty. The quantity of interest is the probability of winning.
  334. clock_solitaire_simulation_test
  335. closest_pair_brute, an Octave code which uses brute force to solve a 2D version of the closest pair problem, which identifies the closest pair of points in a given collection.
  336. closest_pair_brute_test
  337. cobweb_plot, an Octave code which displays a cobweb plot illustrating the process of function iteration.
  338. cobweb_plot_test
  339. coin_simulation, an Octave code which looks at ways of simulating or visualizing the results of many tosses of a fair or biased coin.
  340. coin_simulation_test
  341. collatz, an Octave code which computes and analyzes the Collatz sequence, also known as the hailstone sequence or 3n+1 sequence;
  342. collatz_test
  343. collatz_polynomial, an Octave code which implements the Collatz polynomial iteration, a polynomial analog of the numerical iteration that is also known as the 3n+1 conjecture or the hailstone sequence.
  344. collatz_polynomial_test
  345. collatz_recursive, an Octave code which demonstrates recursive programming by considering the simple Collatz 3n+1 problem.
  346. collatz_recursive_test
  347. collocation, an Octave code which demonstrates the use of collocation to produce a function g(x) that satisfies the same constraints as a function f(x), but only at a discrete set of points.
  348. collocation_test
  349. colored_noise, an Octave code which generates samples of noise obeying a 1/f^alpha power law.
  350. colored_noise_test
  351. combo, an Octave code which includes routines for ranking, unranking, enumerating and randomly selecting balanced sequences, cycles, graphs, Gray codes, subsets, partitions, permutations, restricted growth functions, Pruefer codes and trees.
  352. combo_test
  353. companion_matrix, an Octave code which computes the companion matrix for a polynomial. The polynomial may be represented in the standard monomial basis, or as a sum of Chebyshev, Gegenbauer, Hermite, Laguerre, or Lagrange basis polynomials. All the roots of the polynomial can be determined as the eigenvalues of the corresponding companion matrix.
  354. companion_matrix_test
  355. compass_search, an Octave code which seeks the minimizer of a scalar function of several variables using compass search, a direct search algorithm that does not use derivatives.
  356. compass_search_test
  357. components, an Octave code which organizes contiguous cells into labeled clusters, for a 1D, 2D, or 3D array. This code has uses in image analysis and percolation simulation.
  358. components_test
  359. condition, an Octave code which implements methods of computing or estimating the condition number of a matrix.
  360. condition_test
  361. conservation_ode, an Octave code which monitors the conservation of a quantity that should be constant, during the solution of an ordinary differential equation (ODE).
  362. conservation_ode_test
  363. conte_deboor, an Octave code which contains examples from the text 'Elementary Numerical Analysis' by Conte and deBoor.
  364. conte_deboor_test
  365. continuation, an Octave code which implements the continuation method for a simple 2D problem, involving finding a point on the unit circle, and then finding a sequence of nearby points that trace out the full curve, using only the information available in the implicit definition of the curve from the function f(x,y)=x^2+y^2-1.
  366. continuation_test
  367. continued_fraction an Octave code which implements some simple algorithms for dealing with simple and generalized continued fractions.
  368. continued_fraction_test
  369. control_bio, an Octave code which optimizes a given cost functional of a biological model using optimal control, based on work by Suzanne Lenhart and John Workman.
  370. control_bio_test
  371. convective_rolls_test, an Octave code which plots data describing the convective rolling behavior of a fluid being heated from below, as computed by FreeFem++() and transferred using the ffmatlib() library.
  372. convhull_test, an Octave code which demonstrates the use of the built-in function convhull() for the computation of the convex hull of a set of 2D points.
  373. coordinate_search, an Octave code which seeks the minimizer of a scalar function of several variables, by Jeff Borggaard.
  374. coordinate_search_test
  375. cordic, an Octave code which computes a few special functions using the CORDIC algorithm.
  376. cordic_test
  377. correlation, an Octave code which contains statistical correlation functions.
  378. correlation_test
  379. cosine_transform, an Octave code which demonstrates some simple properties of the discrete cosine transform (DCT).
  380. cosine_transform_test
  381. counterfeit_detection, an Octave code which considers problems in which one or more counterfeit coins are to be identified by the fact that they do not have the standard weight.
  382. counterfeit_detection_test
  383. cplex_solution_read, an Octave code which extracts solution data from a cplex() result file.
  384. cplex_solution_read_test
  385. cpr, an Octave code which implements the Chebyshev Proxy Rootfinder (CPR) to locate all the real zeros of a smooth real function f(x) within an interval [a,b], by John Boyd.
  386. cpr_test
  387. craps_simulation, an Octave code which simulates the gambling game of craps, in which a player rolls two dice. On the first roll, the player wins immediately if a 7 or 11 is rolled, and loses immediately if a 2, 3 or 12 is rolled. Otherwise, the sum of the dice on this first roll is called the point. The player now continues to roll the dice, winning if the point is rolled again, and losing if a 7 is rolled.
  388. craps_simulation_test
  389. crs_io, an Octave code which reads and writes sparse linear systems stored in the Compressed Row Storage (CRS) format.
  390. crs_io_test
  391. cube_arbq_rule, an Octave code which returns quadrature rules, with exactness up to total degree 15, over the interior of the symmetric cube in 3D, by Hong Xiao and Zydrunas Gimbutas.
  392. cube_arbq_rule_test
  393. cube_distance, an Octave code which computes the expected value of the distance between a pair of points randomly selected in the interior of the unit cube in 3D.
  394. cube_distance_test
  395. cube_exactness, an Octave code which investigates the polynomial exactness of quadrature rules over the interior of a cube in 3D.
  396. cube_exactness_test
  397. cube_felippa_rule, an Octave code which returns a Felippa quadrature rules for approximating integrals over the interior of a cube in 3D.
  398. cube_felippa_rule_test
  399. cube_grid, an Octave code which computes a grid of points over the interior of a cube in 3D.
  400. cube_grid_test
  401. cube_integrals, an Octave code which returns the exact value of the integral of any monomial over the interior of the unit cube in 3D.
  402. cube_integrals_test
  403. cube_monte_carlo, an Octave code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit cube in 3D.
  404. cube_monte_carlo_test
  405. cube_surface_distance, an Octave code which estimates the expected value of the distance between a pair of points randomly selected on the surface of the unit cube.
  406. cube_surface_distance_test
  407. cuda_loop, an Octave code which shows how, in a CUDA program running on a Graphics Processing Unit (GPU), the choice of block and thread factors determines the allocation of tasks to processors.
  408. cuda_loop_test
  409. cvt, an Octave code which computes an N-point Centroidal Voronoi Tessellation (CVT) in M dimensions;
  410. cvt_test
  411. cvt_1d_lloyd, an Octave code which computes an N-point Centroidal Voronoi Tessellation (CVT) within the interval [0,1], under a uniform density, using the Lloyd method to compute the Voronoi regions exactly.
  412. cvt_1d_lloyd_test
  413. cvt_1d_lumping, an Octave code which allows the user to carry out a lumped version of the Lloyd iterative algorithm for a centroidal Voronoi Tessellation (CVT() in the interval [-1,+1], and is applied to investigate a relationship between a CVT and the Chebyshev Zero nodes.
  414. cvt_1d_lumping_test
  415. cvt_1d_nonuniform, an Octave code which computes an N-point Centroidal Voronoi Tessellation (CVT) in 1 dimension, under a nonuniform density, and plots the evolution of the locations of the generators during the iteration;
  416. cvt_1d_nonuniform_test
  417. cvt_1d_sampling, an Octave code which computes an N-point Centroidal Voronoi Tessellation (CVT) within the interval [0,1], under a uniform density, using sampling to estimate the Voronoi regions.
  418. cvt_1d_sampling_test
  419. cvt_2d_lumping, an Octave code which computes an N-point Centroidal Voronoi Tessellation (CVT) within the unit square [-1,1]^2, under a Chebyshev density, using weighted sampling (lumping) to estimate the Voronoi regions.
  420. cvt_2d_lumping_test
  421. cvt_2d_sampling, an Octave code which computes an N-point Centroidal Voronoi Tessellation (CVT) within the unit square [0,1]x[0,1], under a uniform density, using sampling to estimate the Voronoi regions.
  422. cvt_2d_sampling_test
  423. cvt_3d_lumping, an Octave code which computes an N-point Centroidal Voronoi Tessellation (CVT) within the unit cube [-1,1]^3, under a Chebyshev density, using weighted sampling (lumping) to estimate the Voronoi regions.
  424. cvt_3d_lumping_test
  425. cvt_3d_sampling, an Octave code which computes an N-point Centroidal Voronoi Tessellation (CVT) within the unit cube [0,1]^3, under a uniform density, using sampling to estimate the Voronoi regions.
  426. cvt_3d_sampling_test
  427. cvt_basic, an Octave code which calculates a Centroidal Voronoi Tessellation (CVT) in a square with uniform density. It is intended as an introduction to the cvt_square_uniform() code.
  428. cvt_basic_test
  429. cvt_circle_nonuniform, an Octave code which demonstrates the computation of a centroidal Voronoi Tessellation (CVT) over a circular region, using a nonuniform density.
  430. cvt_circle_nonuniform_test
  431. cvt_circle_uniform, an Octave code which computes a centroidal Voronoi Tessellation (CVT) over a circular region, using a uniform density.
  432. cvt_circle_uniform_test
  433. cvt_corn, an Octave code which studies a 2D model of the growth of a corn kernel, by treating the surface and interior biological cells as points to be organized by a Centroidal Voronoi Tessellation (CVT) with a nonuniform density; during a sequence of growth steps, new biological cells are randomly added to the surface and interior.
  434. cvt_corn_test
  435. cvt_ellipse_uniform, an Octave code which iteratively calculates a Centroidal Voronoi Tessellation (CVT) over an ellipse, with a uniform density.
  436. cvt_ellipse_uniform_test
  437. cvt_square_nonuniform, an Octave code which iteratively calculates a Centroidal Voronoi Tessellation (CVT) over a square, with a nonuniform density.
  438. cvt_square_nonuniform_test
  439. cvt_square_pdf_discrete, an Octave code which iteratively calculates a Centroidal Voronoi Tessellation (CVT) over a square, with a density determined from a discrete PDF.
  440. cvt_square_pdf_discrete_test
  441. cvt_square_uniform, an Octave code which iteratively calculates a Centroidal Voronoi Tessellation (CVT) over a square, with a uniform density.
  442. cvt_square_uniform_test
  443. cvt_triangle_uniform, an Octave code which iteratively calculates a Centroidal Voronoi Tessellation (CVT) over a triangle, with a uniform density.
  444. cvt_triangle_uniform_test
  445. cvtm_1d, an Octave code which estimates a mirror-periodic centroidal Voronoi Tessellation (CVTM) in the periodic interval [0,1], using a version of the Lloyd iteration.
  446. cvtm_1d_test
  447. cvtp, an Octave code which creates a periodic Centroidal Voronoi Tessellation (CVTP).
  448. cvtp_test
  449. cvtp_1d, an Octave code which estimates a periodic centroidal Voronoi Tessellation (CVTP) in the periodic interval [0,1], using a version of the Lloyd iteration.
  450. cvtp_1d_test
  451. cycle_brent, an Octave code which carries out an iterated function evaluation, and seeks to determine the nearest element of a cycle, and the cycle length, using the Brent method.
  452. cycle_brent_test
  453. cycle_floyd, an Octave code which carries out an iterated function evaluation, and seeks to determine the nearest element of a cycle, and the cycle length, using the Floyd method.
  454. cycle_floyd_test
  455. cyclic_reduction, an Octave code which solves a tridiagonal linear system using cyclic reduction;
  456. cyclic_reduction_test
  457. delaunay_test, an Octave code which calls the built-in delaunay() function, which computes the Delaunay triangulation of a set of points.
  458. delsq, an Octave code which is given a grid G, and returns a corresponding sparse matrix D that defines the Laplacian operator on G. MATLAB includes a built-in version of this function.
  459. delsq_test
  460. dfield9, an Octave code which allows a user to interactively specify the right hand side of an ordinary differential equation (ODE). The program then displays the corresponding direction field. If the user clicks on any point in the image as an initial condition, the program displays the corresponding solution curve. The original version of this code was by John Polking.
  461. dg1d_advection, an Octave code which uses the Discontinuous Galerkin Method (DG) to approximate a solution of the advection equation. The original version of the code was written by Jan Hesthaven and Tim Warburton.
  462. dg1d_advection_test
  463. dg1d_burgers, an Octave code which uses the Discontinuous Galerkin Method (DG) to approximate a solution of the unsteady 1D Burgers equation. The original version of the code was written by Jan Hesthaven and Tim Warburton.
  464. dg1d_burgers_test
  465. dg1d_heat, an Octave code which uses the Discontinuous Galerkin Method (DG) to approximate a solution of the unsteady 1D heat equation. The original version of the code was written by Jan Hesthaven and Tim Warburton.
  466. dg1d_heat_test
  467. dg1d_maxwell, an Octave code which uses the Discontinuous Galerkin Method (DG) to approximate a solution of the Maxwell equations. The original version of the code was written by Jan Hesthaven and Tim Warburton.
  468. dg1d_maxwell_test
  469. dg1d_poisson, an Octave code which applies the discontinuous Galerkin method (DG) to a 1D version of the Poisson equation; the original version of the code was written by Beatrice Riviere.
  470. dg1d_poisson_test
  471. diaphony, an Octave code which reads a file of N points in M dimensions and computes its diaphony, a measure of point dispersion.
  472. diaphony_test
  473. dice_simulation, an Octave code which simulates N tosses of M dice, making a histogram of the resulting sums.
  474. dice_simulation_test
  475. dictionary_code, an Octave code which demonstates how a text file can be compressed and decompressed using a dictionary code.
  476. dictionary_code_test
  477. diff_forward, an Octave code which interactively uses forward differences to estimate the derivative of a function f(x), using a stepsize h.
  478. diff_forward_test
  479. diff_test, an Octave code which calls diff(), which computes differences in a vector of data, which can be scaled to estimate derivatives of equally spaced data.
  480. diff_center, an Octave code which interactively uses centered differences to estimate the derivative of a function f(x), using a stepsize h.
  481. diff_center_test
  482. diff_forward, an Octave code which interactively uses forward differences to estimate the derivative of a function f(x), using a stepsize h.
  483. diff_forward_test
  484. diff2_center, an Octave code which interactively uses centered differences to estimate the second derivative of a function f(x), using a stepsize h.
  485. diff2_center_test
  486. differ, an Octave code which determines the finite difference method (FDM) coefficients to combine function values at known locations to compute an approximation of given accuracy to a derivative of a given order.
  487. differ_test
  488. diffusion_pde, an Octave code which solves the diffusion partial differential equation (PDE) dudt - mu * d2udx2 = 0 in one spatial dimension, with a constant diffusion coefficient mu, and periodic boundary conditions, using the forward time, centered space (FTCS) difference method.
  489. diffusion_pde_test
  490. digital_dice, an Octave code which carries out probability simulations described in "Digital Dice", by Paul Nahin;
  491. digital_dice_test
  492. dijkstra, an Octave code which implements a simple version of the Dijkstra minimum distance algorithm for graphs.
  493. dijkstra_test
  494. diophantine, an Octave code which finds one solution of a diophantine equation in any number of variables.
  495. diophantine_test
  496. diophantine_nd, an Octave code which is given a Diophantine equation in N variables, and returns all nonnegative solutions, or all strictly positive solutions.
  497. diophantine_nd_test
  498. discrete_pdf_sample_2d, an Octave code which demonstrates how to construct a Probability Density Function (PDF) from a table of sample data, and then to use that PDF to create new samples.
  499. discrete_pdf_sample_2d_test
  500. disk_distance, an Octave code which computes the expected value of the distance between a pair of points randomly selected from the interior of the unit disk in 2D.
  501. disk_distance_test
  502. disk_grid, an Octave code which computes grid points within the interior of a disk of user specified radius and center in 2D, using gnuplot to create an image of the grid.
  503. disk_grid_test
  504. disk_integrals, an Octave code which returns the exact value of the integral of any monomial over the interior of a disk of radius R centered at the origin.
  505. disk_integrals_test
  506. disk_monte_carlo, an Octave code which applies a Monte Carlo method to estimate integrals of a function over the interior of the general disk in 2D.
  507. disk_monte_carlo_test
  508. disk_positive_distance, an Octave code which computes the expected value of the distance between a pair of points randomly selected from the interior of the unit positive disk in 2D.
  509. disk_positive_distance_test
  510. disk_rule, an Octave code which computes quadrature rules for the general disk in 2D.
  511. disk_rule_test
  512. disk01_integrals, an Octave code which returns the exact value of the integral of any monomial over the interior of the unit disk in 2D.
  513. disk01_integrals_test
  514. disk01_integrands, an Octave code which defines several test integrals over the unit disk, making it possible to check the accuracy of quadrature rules.
  515. disk01_integrands_test
  516. disk01_monte_carlo, an Octave code which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit disk in 2D;
  517. disk01_monte_carlo_test
  518. disk01_positive_monte_carlo, an Octave code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit positive disk in 2D;
  519. disk01_positive_monte_carlo_test
  520. disk01_positive_rule, an Octave code which computes a quadrature rule over the interior of the unit positive disk in 2D, with radius 1 and center (0,0).
  521. disk01_positive_rule_test
  522. disk01_rule, an Octave code which computes quadrature rules for the unit disk in 2D.
  523. disk01_rule_test
  524. dist_plot, an Octave code which makes contour plots of the distance function, as defined and used in Persson and Strang's distmesh() code;
  525. dist_plot_test
  526. distmesh, an Octave code which carries out a method of mesh generation; by Per-Olof Persson and Gilbert Strang.
  527. distmesh_test
  528. distmesh_3d, an Octave code which carries out a method of mesh generation in 3D, by Per-Olof Persson and Gilbert Strang.
  529. distmesh_3d_test
  530. divdif, an Octave code which uses divided differences to compute the polynomial interpolant to a given set of data.
  531. divdif_test
  532. doomsday, an Octave code which is given the year, month and day of a date, and uses John Conway's doomsday algorithm to determine the corresponding day of the week.
  533. doomsday_test
  534. dosage_ode, an Octave code which sets up and solves a system of ordinary differential equations (ODE) to simulate the blood levels of a medicinal drug that should stay between medicinal and toxic limits.
  535. dosage_ode_test
  536. double_c_data, an Octave code which generates, plots and writes out 2D data that forms two interlocking "C" shapes.
  537. double_c_data_test
  538. double_well_ode, an Octave code which sets up and solves an ordinary differential equation (ODE) which models the motion of a particle in a double well potential.
  539. double_well_ode_test
  540. dream, an Octave code which implements the DREAM algorithm for accelerating Markov Chain Monte Carlo (MCMC) convergence using differential evolution, using five user functions to define the problem, by Guannan Zhang.
  541. dream_test
  542. duel_simulation, an Octave code which simulates N repetitions of a duel between two players, each of whom has a known firing accuracy.
  543. duel_simulation_test
  544. dueling_idiots, an Octave code which carries out the probability simulations described in "Dueling Idiots", by Paul Nahin;
  545. dueling_idiots_test
  546. duffing_ode, an Octave code which sets up and solves a second-order ordinary differential equation (ODE) whose solution can exhibit chaotic behavior.
  547. duffing_ode_test
  548. e_spigot, an Octave code which produces any number of digits of the decimal expansion of e.
  549. e_spigot_test
  550. edge, an Octave code which defines some test functions in 1D, 2D and 3D for the detection of edges or discontinuities.
  551. edge_test
  552. elfun, an Octave code which evaluates elliptic integrals, include Bulirsch's integrals cel(), cel1(), cel2(), cel3(), Carlson integrals rc(), rd(), rf(), rg(), rj(), and Jacobi functions cn(), dn(), sn(), by Milan Batista.
  553. elfun_test
  554. ellipse, an Octave code which carries out geometric calculations for ellipses and ellipsoids, including area, distance to a point, eccentricity, perimeter, points along the perimeter, random sampling, conversion between standard and quadratic forms.
  555. ellipse_test
  556. ellipse_distance, an Octave code which computes the expected value of the distance between a pair of points randomly selected on the circumference of the ellipse (x/a)^2+(y/b)^2=1 in 2D.
  557. ellipse_distance_test
  558. ellipse_grid, an Octave code which computes a grid of points over the interior of an ellipse in 2D.
  559. ellipse_grid_test
  560. ellipse_monte_carlo, an Octave code which uses the Monte Carlo method to estimate the value of integrals over the interior of an ellipse in 2D.
  561. ellipse_monte_carlo_test
  562. ellipsoid, an Octave code which carries out geometric calculations for ellipsoids, including area, random sampling, conversion between standard and quadratic forms.
  563. ellipsoid_test
  564. ellipsoid_grid, an Octave code which computes a grid of points over the interior of an ellipsoid in 3D.
  565. ellipsoid_grid_test
  566. ellipsoid_monte_carlo, an Octave code which uses the Monte Carlo method to estimate the value of integrals over the interior of an ellipsoid in M dimensions.
  567. ellipsoid_monte_carlo_test
  568. elliptic_integral, an Octave code which evaluates complete elliptic integrals of first, second and third kind, using the Carlson elliptic integral functions.
  569. elliptic_integral_test
  570. epicycloid, an Octave code which plots an epicycloid curve.
  571. epicycloid_test
  572. equidistribution, an Octave code which investigates equidistribution properties relating to density functions and point sets.
  573. equidistribution_test
  574. eros, an Octave code which implements elementary row operations (ERO) for the interactive solution of a system of linear equations.
  575. eros_test
  576. errors, an Octave code which illustrates the failure of numerical algorithms;
  577. errors_test
  578. eternity, an Octave code which considers the eternity puzzle, an irregular dodecagon that is to be tiled by 209 pieces, each formed by 12 contiguous 30-60-90 triangles, known as polydrafters.
  579. eternity_test
  580. eternity_hexity, an Octave code which evaluates and manipulates a six-fold parity quantity associated with grids and tiles used in the Eternity puzzle.
  581. eternity_hexity_test
  582. eternity_tile, an Octave code which considers the individual tiles of the eternity puzzle, 209 distinct pieces, each formed by 36 contiguous 30-60-90 triangles, known as polydrafters, as well as tiles for the serenity and trinity puzzles, and the hat and turtle aperiodic monotiles.
  583. eternity_tile_test
  584. euclid, an Octave code which investigates various versions of Euclid's algorithm for computing the greatest common divisor (GCD) of two integers.
  585. euclid_test
  586. euler, an Octave code which solves one or more ordinary differential equations (ODE) using the forward Euler method.
  587. euler_test
  588. exactness, an Octave code which investigates the exactness of quadrature rules that estimate the integral of a function with a density, such as 1, exp(-x) or exp(-x^2), over an interval such as [-1,+1], [0,+oo) or (-oo,+oo).
  589. exactness_test
  590. exm, an Octave code which contains scripts and data discussed in the electronic textbook "Experiments with Matlab", by Cleve Moler, including easter, Fast Fourier Transforms, Fibonacci numbers, the fractal fern, the game of Life, magic matrices, the Mandelbrot set, Morse code, Music, Ordinary Differential Equations, the page rank algorithm, planetary orbits, predator prey equations, the shallow water equations, Sudoku puzzles.
  591. exm_test
  592. exp_ode, an Octave code which sets up and solves an ordinary differential equation (ODE) whose solution is an exponential function.
  593. exp_ode_test
  594. faces_average, an Octave code which averages several images of the same face;
  595. faces_average_test
  596. fair_dice_simulation, an Octave code which simulates N tosses of 2 dice, making a histogram of the resulting sums.
  597. fair_dice_simulation_test
  598. faure, an Octave code which computes the Faure M dimensional Quasi Mont Carlo (QMC) sequence;
  599. faure_test
  600. fd_predator_prey, an Octave code which solves a time-dependent predator prey system using the finite difference method (FDM).
  601. fd_predator_prey_test
  602. fd1d_advection_diffusion_steady, an Octave code which applies the finite difference method (FDM) to solve the steady advection diffusion equation v*ux-k*uxx=0 in one spatial dimension, with constant velocity v and diffusivity k.
  603. fd1d_advection_diffusion_steady_test
  604. fd1d_advection_ftcs, an Octave code which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the forward time centered space (FTCS) difference scheme.
  605. fd1d_advection_ftcs_test
  606. fd1d_advection_lax, an Octave code which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the Lax method to approximate the time derivative.
  607. fd1d_advection_lax_test
  608. fd1d_advection_lax_wendroff, an Octave code which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the Lax-Wendroff method to approximate the time derivative.
  609. fd1d_advection_lax_wendroff_test
  610. fd1d_burgers_lax, an Octave code which applies the finite difference method (FDM) and the Lax Wendroff method to solve the non-viscous time-dependent Burgers equation in one spatial dimension.
  611. fd1d_burgers_lax_test
  612. fd1d_burgers_leap, an Octave code which applies the finite difference method (FDM) and the leapfrog approach to solve the non-viscous time-dependent Burgers equation in one spatial dimension.
  613. fd1d_burgers_leap_test
  614. fd1d_bvp, an Octave code which applies the finite difference method (FDM) to a two point boundary value problem (BVP) in one spatial dimension.
  615. fd1d_bvp_test
  616. fd1d_display, an Octave code which reads a pair of files defining a 1D finite difference method (FDM) of a function, and plots the data.
  617. fd1d_display_test
  618. fd1d_heat_explicit, an Octave code which implements a finite difference method (FDM), explicit in time, to solve the time dependent 1D heat equation;
  619. fd1d_heat_explicit_test
  620. fd1d_heat_implicit, an Octave code which implements a finite difference method (FDM), implicit in time, to solve the time dependent 1D heat equation;
  621. fd1d_heat_implicit_test
  622. fd1d_heat_steady, an Octave code which implements a finite difference method (FDM) for the steady (time independent) 1D heat equation;
  623. fd1d_heat_steady_test
  624. fd1d_poisson, an Octave code which solves a Poisson equation over a user-specified discretized interval, with given functions f(x) (right hand side) and g(x) (Dirichlet boundary conditions), using the Finite Difference Method (FDM).
  625. fd1d_poisson_test
  626. fd1d_predator_prey, an Octave code which implements the finite difference method (FDM) for a predator-prey system with time and 1D spatial dependence, by Marcus Garvie.
  627. fd1d_predator_prey_test
  628. fd1d_predator_prey_plot, an Octave code which plots solutions of the predator prey differential equations, by Marcus Garvie.
  629. fd1d_predator_prey_plot_test
  630. fd1d_wave, an Octave code which applies the finite difference method (FDM) to solve the time-dependent wave equation utt = c * uxx in one spatial dimension.
  631. fd1d_wave_test
  632. fd2d_convergence_test, an Octave code which calls fd2d_poisson(), which repeatedly solves a Poisson equation on a sequence of finer meshes, so that the relationship between mesh size H and error norm E can be explored.
  633. fd2d_heat_steady, an Octave code which implements a finite difference method (FDM) for the steady (time independent) 2D heat equation;
  634. fd2d_heat_steady_test
  635. fd2d_poisson, an Octave code which solves a Poisson equation over a user-specified discretized rectangle, with given functions f(x,y) (right hand side) and g(x,y) (Dirichlet boundary conditions), using the Finite Difference Method (FDM).
  636. fd2d_poisson_test
  637. fd2d_predator_prey, an Octave code which implements a finite difference method (FDM) for a time and 2D space dependent predator-prey system, by Marcus Garvie.
  638. fd2d_predator_prey_test
  639. fd3d_poisson, an Octave code which solves a Poisson equation over a user-specified discretized 3d block, with given functions f(x,y,z) (right hand side) and g(x,y,z) (Dirichlet boundary conditions), using the Finite Difference Method (FDM).
  640. fd3d_poisson_test
  641. fem_basis, an Octave code which defines and evaluates finite element method (FEM) basis functions for any degree in an M dimensional simplex (1D interval, 2D triangle, 3D tetrahedron, and higher dimensional generalizations.)
  642. fem_basis_test
  643. fem_basis_q4_display, an Octave code which displays any single finite element method (FEM) basis function associated with an arbitrary linear quadrilateral Q4 mesh;
  644. fem_basis_q4_display_test
  645. fem_basis_t3_display, an Octave code which displays a basis function for the finite element method (FEM) associated with an arbitrary 3-node triangle T3 mesh;
  646. fem_basis_t3_display_test
  647. fem_basis_t4_display, an Octave code which displays a basis function for the finite element method (FEM) associated with an arbitrary 4-node triangle T4 mesh;
  648. fem_basis_t4_display_test
  649. fem_basis_t6_display, an Octave code which displays a basis function for the finite element method (FEM) associated with an arbitrary 6-node triangle T6 mesh;
  650. fem_basis_t6_display_test
  651. fem_io, an Octave code which reads or writes FEM files, which describe the nodes, elements, and function values associated with a finite element method (FEM) model;
  652. fem_io_test
  653. fem_neumann, an Octave code which sets up a time-dependent reaction-diffusion equation in 1D, with Neumann boundary conditions, discretized using the finite element method (FEM).
  654. fem_neumann_test
  655. fem_to_gmsh, an Octave code which reads a pair of FEM files defining node coordinates and elements, of a 1D, 2D or 3D mesh, namely a file of node coordinates and a file of elements defined by node indices, and creates a gmsh() MESH file.
  656. fem_to_gmsh_test
  657. fem_to_medit, an Octave code which reads a set of FEM files defining the node coordinates, boundary nodes, and elements of a finite element mesh, and rewrites the data as a medit() MESH file.
  658. fem_to_medit_test
  659. fem_to_triangle, an Octave code which reads FEM files defining a 2D mesh of triangles, namely a file of node coordinates and a file of elements defined by node indices, and creates a corresponding pair of node and element files for use by Jonathan Shewchuk's triangle() program.
  660. fem_to_triangle_test
  661. fem_to_xml, an Octave code which reads a pair of FEM files defining node coordinates and elements, of a 1D, 2D or 3D mesh, namely a file of node coordinates and a file of elements defined by node indices, and creates a corresponding XML file for input to dolfin() or fenics().
  662. fem_to_xml_test
  663. fem1d, an Octave code which applies the finite element method (FEM), using piecewise linear basis functions, to a linear two point boundary value problem (BVP) in 1D;
  664. fem1d_test
  665. fem1d_adaptive, an Octave code which uses an adaptive mesh when applying the finite element method (FEM), with piecewise linear (PWL) basis functions, to a linear two point boundary value problem (BVP) in 1D;
  666. fem1d_adaptive_test
  667. fem1d_approximate, an Octave code which uses a given finite element method (FEM) mesh and piecewise linear (PWL) basis functions to approximate a set of data points, while controlling the variation in the derivative.
  668. fem1d_approximate_test
  669. fem1d_bvp_linear, an Octave code which applies the finite element method (FEM), with piecewise linear (PWL) elements, to a two point boundary value problem (BVP) in one spatial dimension, and compares the computed and exact solutions with the L2 and seminorm errors.
  670. fem1d_bvp_linear_test
  671. fem1d_bvp_quadratic, an Octave code which applies the finite element method (FEM), with piecewise quadratic (PWQ) elements, to a two point boundary value problem (BVP) in one spatial dimension, and compares the computed and exact solutions with the L2 and seminorm errors.
  672. fem1d_bvp_quadratic_test
  673. fem1d_display, an Octave code which reads three files defining a 1D arbitrary degree basis function associated with the finite element method (FEM), and displays a plot.
  674. fem1d_display_test
  675. fem1d_function_10_display, an Octave code which reads three files defining a 1D piecewise linear finite element method (FEM) function and displays a plot.
  676. fem1d_display_function_10_test
  677. fem1d_heat_explicit, an Octave code which uses the finite element method (FEM) and explicit time stepping to solve the time dependent heat equation in 1D.
  678. fem1d_heat_explicit_test
  679. fem1d_heat_implicit, an Octave code which uses the finite element method (FEM) and implicit time stepping to solve the time dependent heat equation in 1D.
  680. fem1d_heat_implicit_test
  681. fem1d_heat_steady, an Octave code which uses the finite element method (FEM) to solve the steady (time independent) 1D heat equation;
  682. fem1d_heat_steady_test
  683. fem1d_lagrange, an Octave code which sets up the matrices and vectors associated with the finite element method (FEM) solution of a boundary value problem (BVP) -u''+u=f(x), using Lagrange basis polynomials.
  684. fem1d_lagrange_test
  685. fem1d_nonlinear, an Octave code which applies the finite element method (FEM), with piecewise linear (PWL) basis functions, to a nonlinear two point boundary value problem (BVP) in 1D;
  686. fem1d_nonlinear_test
  687. fem1d_pack, an Octave code which contains utilities for 1D finite element method (FEM) calculations.
  688. fem1d_pack_test
  689. fem1d_pmethod, an Octave code which applies the p-method version of the finite element method (FEM) to a linear two point boundary value problem (BVP) in 1D;
  690. fem1d_pmethod_test
  691. fem1d_project, an Octave code which projects data into a finite element space, including the least squares approximation of data, or the projection of a finite element solution from one mesh to another.
  692. fem1d_project_test
  693. fem1d_sample, an Octave code which samples a scalar or vector finite element function of one variable, defined by FEM files, returning interpolated values at the sample points.
  694. fem1d_sample_test
  695. fem2d_bvp_linear, an Octave code which applies the finite element method (FEM), with piecewise linear (PWL) elements, to a 2D boundary value problem (BVP) in a rectangle, and compares the computed and exact solutions with the L2 and seminorm errors.
  696. fem2d_bvp_linear_test
  697. fem1d_bvp_quadratic, an Octave code which applies the finite element method (FEM), with piecewise quadratic (PWQ) elements, to a two point boundary value problem (BVP) in one spatial dimension, and compares the computed and exact solutions with the L2 and seminorm errors.
  698. fem1d_bvp_quadratic_test
  699. fem2d_bvp_serene, an Octave code which applies the finite element method (FEM), with serendipity elements, to a 2D boundary value problem (BVP) in a rectangle, and compares the computed and exact solutions with the L2 and seminorm errors.
  700. fem2d_bvp_serene_test
  701. fem2d_heat, an Octave code which applies the finite element method (FEM) to the time dependent heat equation on an arbitrary triangulated region in 2D;
  702. fem2d_heat_test
  703. fem2d_heat_rectangle, an Octave code which applies the finite element method (FEM) for the time-dependent heat equation on a triangulated rectangle in 2D;
  704. fem2d_heat_rectangle_test
  705. fem2d_heat_sparse, an Octave code which applies the finite element method (FEM) to the heat equation on an arbitrary triangulated region in 2D, using a sparse storage matrix format;
  706. fem2d_heat_sparse_test
  707. fem2d_mesh_display, an Octave code which reads a FEM model of a 2D mesh of elements of any uniform order and displays a plot of the elements and nodes, with optional numbering.
  708. fem2d_mesh_display_test
  709. fem2d_pack, an Octave code which performs simple 2D finite element method (FEM) computations;
  710. fem2d_pack_test
  711. fem2d_poisson_rectangle, an Octave code which solves the 2D Poisson equation on a rectangle, using the finite element method (FEM), and piecewise quadratic triangular elements.
  712. fem2d_poisson_rectangle_test
  713. fem2d_poisson_rectangle_linear, an Octave code which solves the 2D Poisson equation on a rectangle, using the finite element method (FEM), and piecewise linear triangular elements.
  714. fem2d_poisson_rectangle_linear_test
  715. fem2d_predator_prey_fast, an Octave code which implements a finite element method (FEM) for a time and 2D space dependent predator-prey system, on an arbitrary triangulated region, with a variety of possible boundary conditions, incorporating some optimizations, by Marcus Garvie.
  716. fem2d_predator_prey_fast_test
  717. fem2d_project, an Octave code which projects a function f(x,y), given as data, into a given finite element method (FEM) space of piecewise linear triangular elements.
  718. fem2d_project_test
  719. fem2d_project_function, an Octave code which projects a function f(x,y), given as a formula, into a given finite element method (FEM) space of piecewise linear triangular elements.
  720. fem2d_project_function_test
  721. fem2d_sample, an Octave code which samples a finite element method (FEM) function, defined by three text files describing the nodes, triangles, and coefficients, at arbitrary points.
  722. fem2d_sample_test
  723. fem2d_scalar_display, an Octave code which reads information about nodes, elements and nodal values for a 2D finite element method (FEM) and creates a surface plot of U(X,Y).
  724. fem2d_scalar_display_test
  725. fem2d_scalar_display_brief, an Octave code which reads information about nodes, elements and nodal values for a 2D finite element method (FEM) and creates a surface plot of U(X,Y), in 5 lines of code.
  726. fem2d_scalar_display_brief_test
  727. fem2d_scalar_display_gpl, an Octave code which reads information about nodes, elements and nodal values for a 2D finite element method (FEM) and creates a GPL file describing a surface plot of U(X,Y), which can be displayed by gnuplot().
  728. fem2d_scalar_display_gpl_test,
  729. fem3d_pack, an Octave code which contains utilities for 3D finite element method (FEM) calculations.
  730. fem3d_pack_test
  731. fem3d_project, an Octave code which projects a function f(x,y,z), given as a data, into a given space of piecewise linear tetrahedral elements for use in the finite element method (FEM).
  732. fem3d_project_test
  733. fem3d_sample, an Octave code library which evaluates a function defined on a 3D tetrahedral mesh as part of the finite element method (FEM).
  734. fem3d_sample_test
  735. fern, an Octave code which computes and displays the Barnsley fractal fern.
  736. fern_test
  737. ffmatlib, an Octave code which allows the user to plot finite element method (FEM) results that have been computed by FreeFem++().
  738. fft_serial, an Octave code which computes a Fast Fourier Transform (FFT), and is intended as a starting point for implementing a parallel version.
  739. fft_serial_test
  740. fibonacci_spiral, an Octave code which displays points on a Fibonacci spiral, suggesting the arrangement of seeds in a sunflower, for instance.
  741. fibonacci_spiral_test
  742. filon_rule, an Octave code which approximates integrals which include an oscillatory factor of sin(k*x) or cos(k*x).
  743. filon_rule_test
  744. fire_simulation, an Octave code which simulates a forest fire over a rectangular array of trees, starting at a single random location.
  745. fire_simulation_test
  746. fitzhugh_nagumo_ode, an Octave code which sets up and solves the Fitzhugh-Nagumo system of ordinary differential equations (ODE).
  747. fitzhugh_nagumo_ode_test
  748. flame_ode, an Octave code which sets up and solves an ordinary differential equation (ODE) which models the growth of a ball of flame in a combustion process. The exact solution is defined in terms of the Lambert W function.
  749. flame_ode_test
  750. flies_simulation, an Octave code which simulates an experiment in which two flies land on a plate of radius 1. By repeating the experiment many times, the average distance between the flies is to be estimated.
  751. flies_simulation_test
  752. floyd, an Octave code which implements the Floyd algorithm for finding the shortest distance between pairs of nodes on a directed graph.
  753. floyd_test
  754. fly_simulation, an Octave code which simulates an experiment in which a fly lands on a plate of radius 1. By repeating the experiment many times, the average distance of the fly from the center is to be estimated.
  755. fly_simulation_test
  756. fn, an Octave code which evaluates elementary and special functions using Chebyshev polynomials, including Airy, Bessel I, Bessel J, Bessel K, Bessel Y, beta, confluent hypergeometric, cosine integral, the Dawson integral, digamma (psi), error, exponential integral, gamma, hyperbolic cosine integral, hyperbolic sine integral, incomplete gamma, log gamma, logarithmic integral, Pochhammer, psi, sine integral, Spence;, by Wayne Fullerton.
  757. fn_test
  758. football_dynamic, an Octave code which uses dynamic programming to count the ways of achieving a given score in football.
  759. football_dynamic_test
  760. four_fifths, an Octave code which searches for a solution to the problem of finding four fifth powers that sum to a fifth power, that is, integers a, b, c, d and e such that a^5+b^5+c^5+d^5=e^5. Euler conjectured that no solution was possible.
  761. four_fifths_test
  762. fsolve_test, an Octave code which calls fsolve() which seeks the solution x of one or more nonlinear equations f(x)=0.
  763. full_deck_simulation, an Octave code which simulates a process in which a random card is drawn from a deck of 52, and then replaced, continuing until every card has been seen at least once.
  764. full_deck_simulation_test
  765. gamblers_ruin_simulation, an Octave code which simulates a game in which a gambler never stops playing until all money is lost.
  766. gamblers_ruin_simulation_test
  767. gauss_seidel, an Octave code which implements the Gauss-Seidel iteration for linear systems.
  768. gauss_seidel_test
  769. gauss_seidel_poisson_1d, an Octave code which demonstrates how the linear system for a discretized version of the steady 1D Poisson equation can be solved by the Gauss-Seidel iteration.
  770. gauss_seidel_poisson_1d_test
  771. gauss_seidel_stochastic, an Octave code which uses a stochastic version of the Gauss-Seidel iteration to solve a linear system with a symmetric positive definite (SPD) matrix.
  772. gauss_seidel_stochastic_test
  773. gaussian, an Octave code which evaluates the Gaussian function and its derivatives.
  774. gaussian_test,
  775. gaussian_2d, an Octave code which evaluates a general Gaussian function of a 2D argument.
  776. gaussian_2d_test,
  777. gaussian_prime_spiral, an Octave code which computes a twisting spiral path along the Gaussian primes, and displays a plot of the total trajectory.
  778. gaussian_prime_spiral_test
  779. ge_to_crs, an Octave code which converts a matrix from General (GE) to Compressed Row Storage (CRS) format.
  780. ge_to_crs_test
  781. gegenbauer_cc, an Octave code which computes the Gegenbauer weighted integral of a function f(x) using a Clenshaw-Curtis approach.
  782. gegenbauer_cc_test
  783. gegenbauer_exactness, an Octave code which tests the polynomial exactness of Gauss-Gegenbauer quadrature rules.
  784. gegenbauer_exactness_test
  785. gegenbauer_polynomial, an Octave code which evaluates the Gegenbauer polynomial and associated functions.
  786. gegenbauer_polynomial_test
  787. gegenbauer_rule, an Octave code which computes and writes out a Gauss-Gegenbauer quadrature rule of given order.
  788. gegenbauer_rule_test
  789. gen_hermite_exactness, an Octave code which tests the polynomial exactness of generalized Gauss-Hermite quadrature rules.
  790. gen_hermite_exactness_test
  791. gen_hermite_rule, an Octave code which computes and writes out a generalized Gauss-Hermite quadrature rule of given order and parameter value.
  792. gen_hermite_rule_test
  793. gen_laguerre_exactness, an Octave code which tests the polynomial exactness of generalized Gauss-Laguerre quadrature rules.
  794. gen_laguerre_exactness_test
  795. gen_laguerre_rule, an Octave code which computes and writes out a generalized Gauss-Laguerre quadrature rule of given order and parameter value.
  796. gen_laguerre_rule_test
  797. geometry, an Octave code which performs geometric calculations in 2, 3 and M dimensional space, including the computation of angles, areas, containment, distances, intersections, lengths, and volumes.
  798. geometry_test
  799. geompack, an Octave code which computes Delaunay triangulations, Voronoi diagrams, and other information, by Barry Joe.
  800. geompack_test
  801. gl_fast_rule, an Octave code which carries out the rapid computation of the Kth value and weight of an N point Gauss-Legendre quadrature rule, by Ignace Bogaert.
  802. gl_fast_rule_test
  803. glomin, an Octave code which finds a global minimum of a scalar function of a scalar variable, without the use of derivative information, by Richard Brent.
  804. glomin_test
  805. glycolysis_ode, an Octave code which sets up a pair of ordinary differential equations (ODE) that model the biochemical process of glycolysis, for which a limit cycle exists.
  806. glycolysis_ode_test
  807. gmres, an Octave code which implements the generalized minimum residual (GMRES) method for solving a nonsymmetric sparse linear system A*x=b.
  808. gmres_test
  809. gmsh_io, an Octave code which reads or writes files created by the gmsh() program for 1D, 2D or 3D meshes used by the finite element method (FEM).
  810. gmsh_io_test
  811. gmsh_to_fem, an Octave code which reads a mesh data file created by the gmsh() program and writes a pair of node and element files that correspond to the FEM format.
  812. gmsh_to_fem_test
  813. gnuplot_test, an Octave code which uses gnuplot() to create various kinds of plots.
  814. gpl_display, an Octave code which tries to read the data in a typical gnuplot() GPL file, describing a 1D, 2D or 3D curve, or a surface Z(X,Y) defined on a regular grid, a triangular grid, or an irregular quadrilateral grid, displays it in a more attractive way than gnuplot() is capable of.
  815. gpl_display_test
  816. gradient_descent, an Octave code which uses gradient descent to solve a linear least squares (LLS) problem.
  817. gradient_descent_test
  818. gram_polynomial, an Octave code which evaluates the Gram polynomials, also known as the discrete Chebyshev polyomials and associated functions.
  819. gram_polynomial_test
  820. gram_schmidt, an Octave code which implements the Gram-Schmidt process to orthogonalize and normalize a set of vectors.
  821. gram_schmidt_test
  822. graph_adj, an Octave code which carries out operations on abstract graphs, with undirected edges, described by an adjacency matrix. Operations include breadth-first search, the computation of a minimum spanning tree, an Euler or Hamilton circuit, blocks, chromatic polynomial, or transitive closure.
  823. graph_adj_test
  824. graph_representation, an Octave code which can determine various representations of a graph.
  825. graph_representation_test
  826. graphics_test, an Octave code which graphically displays various kinds of data.
  827. grazing_ode, an Octave code which sets up and solves a pair of ordinary differential equations (ODE) that model the populations of an edible plant, and the herbivore that grazes on it.
  828. gray_code_display, an Octave code which computes the Hamming distance tables for both the binary and Gray codes, and displays 3D plots that illustrate how the Gray code does a better job of providing nearby representations for nearby numbers.
  829. gray_code_display_test
  830. grazing_ode_test
  831. grf_display, an Octave code which reads a GRF file defining a mathematical graph and displays an image of it.
  832. grf_display_test
  833. grf_io, an Octave code which reads or writes a grf file which represents a mathematical graph;
  834. grf_io_test
  835. grid_display, an Octave code which reads a file of points on a grid or sparse grid, displays the grid and saves the image in a png file;
  836. grid_display_test
  837. gridlines, an Octave code which gives the user more control over drawing gridlines on a graph than is available through the builtin grid() command.
  838. gridlines_test
  839. grids_display, an Octave code which reads two files of grids or sparse grids, displaying the first with hollow blue dots, the second with solid red dots.
  840. grids_display_test
  841. gurobi_solution_read, an Octave code which reads a file created by the optimization package GUROBI, representing the solution of a polyomino tiling problem, and writes out a simple ASCII file that can be read by load().
  842. gurobi_solution_read_test
  843. haar_transform, an Octave code which computes the Haar transform of 1d or 2d data.
  844. haar_transform_test
  845. halton, an Octave code which computes elements of a Halton Quasi Monte Carlo (QMC) sequence, using a simple interface.
  846. halton_test
  847. hammersley, an Octave code which computes elements of a Hammersley Quasi Monte Carlo (QMC) sequence, using a simple interface.
  848. hammersley_test
  849. hamming, an Octave code which implements some simple versions of Hamming codes which can detect and correct errors in data.
  850. hamming_test
  851. hand_area, an Octave code which estimates the area of a curve which outlines a hand.
  852. hand_area_test
  853. hand_data, an Octave code which carries out some numerical exercises based on data that came from tracing several points on a hand.
  854. hand_data_test
  855. hand_mesh2d, an Octave code which reads in a set of points which outline a human hand, and calls mesh2d(), which is able to create a fine triangular mesh of the region outlined by the points.
  856. hand_mesh2d_test
  857. hankel_cholesky, an Octave code which computes the upper Cholesky factor R of a symmetric positive definite (SPD) Hankel matrix H so that H = R' * R.
  858. hankel_cholesky_test
  859. hankel_inverse, an Octave code which computes the inverse of a Hankel matrix.
  860. hankel_inverse_test
  861. hankel_spd, an Octave code which computes a lower triangular matrix L which is the Cholesky factor of a symmetric positive definite (SPD) Hankel matrix H, that is, H = L * L'.
  862. hankel_spd_test
  863. hb_io, an Octave code which reads and writes sparse linear systems stored in the Harwell Boeing (HB) format for sparse matrices.
  864. hb_io_test
  865. hb_to_mm, an Octave code which converts a sparse matrix from Harwell Boeing (HB) to Matrix Market (MM) format.
  866. hb_to_mm_test
  867. hb_to_msm, an Octave code which converts a sparse matrix stored in a Harwell Boeing (HB) format to MATLAB sparse matrix (MSM) format;
  868. hb_to_msm_test
  869. hb_to_st, an Octave code which converts a sparse matrix from Harwell Boeing (HB) format to Sparse Triplet (ST) format.
  870. hb_to_st_test
  871. heartbeat_ode, an Octave code which sets up and solves an ordinary differential equation (ODE) describing the beating of the heart, as suggested by Zeeman.
  872. heartbeat_ode_test
  873. heat_transfer_test, an Octave code which plots data from the computation of heat distribution on a metal disk, as computed by FreeFem++() and transferred using the ffmatlib() library.
  874. heated_plate, an Octave code which solves the steady state heat equation in a 2D rectangular region, and is intended as a starting point for a parallel version.
  875. heated_plate_test
  876. hello, an Octave code which prints out "Hello, world!".
  877. hello_test
  878. henon_heiles_ode, an Octave code which sets up and solves the Henon-Heiles system of ordinary differential equations (ODE) which model the motion of a star around the galactic center.
  879. henon_heiles_ode_test
  880. henon_orbit, a MATLAB code which computes the orbit of the Henon map for various sets of initial data.
  881. henon_orbit_test
  882. hermite_cubic, an Octave code which computes the value, derivatives or integral of a Hermite cubic polynomial, or manipulates an interpolating function made up of piecewise Hermite cubic polynomials.
  883. hermite_cubic_test
  884. hermite_exactness, an Octave code which tests the polynomial exactness of Gauss-Hermite quadrature rules to estimate the integral of a function with density exp(-x^2) over the interval (-oo,+oo).
  885. hermite_exactness_test
  886. hermite_integrands, an Octave code which defines test integrands for Hermite integrals with density exp(-x^2) over the interval (-oo,+oo).
  887. hermite_integrands_test
  888. hermite_interpolant, an Octave code which computes the Hermite interpolant, a polynomial that matches function values and derivatives.
  889. hermite_interpolant_test
  890. hermite_polynomial, an Octave code which evaluates the physicist's Hermite polynomial, the probabilist's Hermite polynomial, the Hermite function, and related functions.
  891. hermite_polynomial_test
  892. hermite_product_display, an Octave code which displays an image of a function created by the Cartesian product of two Hermite polynomials, such as f(x,y) = h(3,x) * h(1,y).
  893. hermite_product_display_test
  894. hermite_product_polynomial, an Octave code which defines Hermite product polynomials, creating a multivariate polynomial as the product of univariate Hermite polynomials.
  895. hermite_rule, an Octave code which computes and writes out a Gauss-Hermite quadrature rule to estimate the integral of a function with density exp(-x^2) over the interval (-oo,+oo).
  896. hexagon_integrals, an Octave code which returns the exact value of the integral of a monomial over the interior of a hexagon in 2D.
  897. hexagon_integrals_test
  898. hexagon_lyness_rule, an Octave code which computes one of 13 Lyness quadrature rules over the interior of the unit hexagon.
  899. hexagon_lyness_rule_test
  900. hexagon_monte_carlo, an Octave code which applies a Monte Carlo method to estimate the integral of a function over the interior of a hexagon in 2D;
  901. hexagon_monte_carlo_test
  902. hexagon_stroud_rule, an Octave code which computes one of four Stroud quadrature rules over the interior of the unit hexagon.
  903. hexagon_stroud_rule_test
  904. hexahedron_jaskowiec_rule, an Octave code which returns a symmetric Jaskowiec quadrature rule for the hexahedron, with exactness up to total degree 21.
  905. hexahedron_jaskowiec_rule_test
  906. hexahedron_witherden_rule, an Octave code which returns a symmetric Witherden quadrature rule for the hexahedron, with exactness up to total degree 11.
  907. hexahedron_witherden_rule_test
  908. high_card_simulation, an Octave code which simulates a situation in which you see the cards in a deck one by one, and must select the one you think is the highest and stop.
  909. high_card_simulation_test
  910. hilbert_curve, an Octave code which computes the sequence of discrete Hilbert curves whose limit is a space-filling curve.
  911. hilbert_curve_test
  912. hilbert_curve_display, an Octave code which plots a Hilbert curve of given order.
  913. hilbert_curve_display_test
  914. histogram_data_2d_sample, an Octave code which demonstrates how to construct a Probability Density Function (PDF) from sample data over a 2D domain, and then to use that PDF to create new samples.
  915. histogram_data_2d_sample_test
  916. histogram_discrete, an Octave code which tries to make a histogram of data without using bins.
  917. histogram_discrete_test
  918. histogram_pdf, an Octave code which creates a histogram plot of a set of data, normalized to estimate the probability density function (PDF).
  919. histogram_pdf_test
  920. histogram_pdf_2d_sample, an Octave code which demonstrates how uniform sampling of a 2D region with respect to some known Probability Density Function (PDF) can be approximated by decomposing the region into rectangles, approximating the PDF by a piecewise constant (PWC) function, constructing a histogram for the CDF, and then sampling.
  921. histogram_pdf_2d_sample_test
  922. histogramize, an Octave code which takes a vector of data and organizes it into a histogram of a given number of bins with given width and range, which can be displayed as a bar chart.
  923. histogramize_test
  924. hits, an Octave code which uses the HITS algorithm to assign authority and hub indices to a set of nodes in a directed network.
  925. hits_test
  926. house, an Octave code which includes a line segment outline of a house, and some programs to show how linear transformations affect the shape, by Cleve Moler.
  927. house_test
  928. human_data, an Octave code which starts with an image of simple outline of a human body, tabulates a sequence of points on the outline, creating numerical data defining the boundary. It is then able to fill the region with mesh points and triangulate the region. This allows the region to be analyzed by the finite element method (FEM).
  929. human_data_test
  930. humps, an Octave code which evaluates the humps() function, its first and second derivatives and its antiderivative.
  931. humps_test
  932. humps_ode, an Octave code which sets up and solves an ordinary differential equation (ODE) whose solution is a double hump curve.
  933. humps_ode_test
  934. hyper_2f1, an Octave code which evaluates the hypergeometric functions 2F1(a,b,c;x) for real parameters a, b, c and argument x. This function is simply a wrapper for the Gnu Scientific Library function gsl_sf_hyperg_2F1().
  935. hyper_2f1_test
  936. hyperball_distance, an Octave code which computes the expected value of the distance between a pair of points randomly selected from the interior of the unit hyperball in M dimensions.
  937. hyperball_distance_test
  938. hyperball_integrals, an Octave code which returns the exact value of the integral of any monomial over the interior of the unit hyperball in M dimensions.
  939. hyperball_integrals_test
  940. hyperball_monte_carlo, an Octave code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit ball in M dimensions;
  941. hyperball_monte_carlo_test
  942. hyperball_positive_distance, an Octave code which computes the expected value of the distance between a pair of points randomly selected from the interior of the unit positive hyperball in M dimensions.
  943. hyperball_positive_distance_test
  944. hypercube_distance, an Octave code which estimates the expected value of the distance between a pair of points randomly selected in the M-dimensional unit hypercube.
  945. hypercube_distance_test
  946. hypercube_exactness, an Octave code which tests the polynomial exactness of a quadrature rule over the interior of the unit hypercube in M dimensions.
  947. hypercube_exactness_test
  948. hypercube_grid, an Octave code which computes a grid of points over the interior of a hypercube in M dimensions.
  949. hypercube_grid_test
  950. hypercube_integrals, an Octave code which returns the exact value of the integral of any monomial over the interior of the unit hypercube in M dimensions.
  951. hypercube_integrals_test
  952. hypercube_monte_carlo, an Octave code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit hypercube in M dimensions.
  953. hypercube_monte_carlo_test
  954. hypercube_surface_distance, an Octave code which estimates the expected value of the distance between a pair of points randomly selected on the surface of the unit hypercube in D dimensions.
  955. hypercube_surface_distance_test
  956. hypersphere, an Octave code which carries out various operations for an M dimensional hypersphere, including converting between Cartesian and spherical coordinates, stereographic projection, sampling the surface of the sphere, and computing the surface area and volume.
  957. hypersphere_test
  958. hypersphere_angle_distance, an Octave code which considers the problem of describing the typical value of the angle between a pair of points randomly selected on the unit hypersphere in M dimensions. Since by symmetry, this will be zero, we instead look at the average of the absolute value of the dot product, and the corresponding angle. In dimension 1, we have average dot product of 1, and angle 0. As the dimension increases, the average dot product rapidly decreases to 0, while the average angle goes to 90 degrees.
  959. hypersphere_angle_distance_test
  960. hypersphere_distance, an Octave code which computes the expected value of the distance between a pair of points randomly selected on the surface of the unit hypersphere in M dimensions.
  961. hypersphere_distance_test
  962. hypersphere_integrals, an Octave code which returns the exact value of the integral of any monomial over the surface of the unit hypersphere in M dimensions.
  963. hypersphere_integrals_test
  964. hypersphere_monte_carlo, an Octave code which applies a Monte Carlo method to estimate the integral of a function on the surface of the unit sphere in M dimensions;
  965. hypersphere_monte_carlo_test
  966. hypersphere_positive_distance, an Octave code which computes the expected value of the distance between a pair of points randomly selected on the surface of the unit positive hypersphere in M dimensions.
  967. hypersphere_positive_distance_test
  968. i4lib, an Octave code which contains many utility routines, using single precision integer (I4) arithmetic.
  969. i4lib_test
  970. i4mat_rref2, an Octave code which computes a version of the reduced row echelon form of an integer matrix.
  971. i4mat_rref2_test
  972. image_mesh, an Octave code which starts with a list of points that bound some region, and calls mesh2d() to create a mesh of the interior.
  973. image_mesh_test
  974. image_sample, an Octave code which allows the user to specify an image file to be displayed. The user may then use the mouse to select points on the image. The coordinates of each point are saved to a file. Selection ends with a RETURN. An example is supplied, which outlines the boundary of an aneurysm.
  975. image_sample_test
  976. index, an Octave code which converts an M-dimensional vector index to a one-dimensional vector index; it handles zero and one based indexing schemes, as well as column major and row major conventions.
  977. index_test
  978. insurance_simulation, an Octave code which simulates a highly simplified model of term life insurance, in which a customer agrees to pay an annual fee for a given number of years, so that if the customer dies within that term, the family receives a large payout.
  979. insurance_simulation_test
  980. interp, an Octave code which parameterizes and interpolates data;
  981. interp_test
  982. is_gaussian_prime, an Octave code which is true if a given complex number c is a Gaussian prime.
  983. is_gaussian_prime_test
  984. is_prime, an Octave code which implements various versions of the sieve of Eratosthenes to determine whether a given integer is prime.
  985. is_prime_test
  986. isbn, an Octave code which determines the check digit for an International Standard Book Number (ISBN) or reports whether a given ISBN is valid.
  987. isbn_test
  988. ising_2d_simulation, an Octave code which simulates the evolution of a 2D array of positive and negative charges, each of which is likely to flip to be in agreement with neighbors.
  989. ising_2d_simulation_test
  990. jaccard_distance, an Octave code which computes the Jaccard distance between two sets.
  991. jaccard_distance_test
  992. jacobi, an Octave code which implements the Jacobi iteration for the iterative solution of linear systems.
  993. jacobi_test
  994. jacobi_eigenvalue, an Octave code which implements the Jacobi iteration for the iterative determination of the eigenvalues and eigenvectors of a real symmetric matrix.
  995. jacobi_eigenvalue_test
  996. jacobi_exactness, an Octave code which tests the polynomial exactness of rules for integrals with a Jacobi weight function.
  997. jacobi_exactness_test
  998. jacobi_poisson_1d, an Octave code which uses Jacobi iteration to solve the linear system for a discretized steady 1D Poisson equation.
  999. jacobi_poisson_1d_test
  1000. jacobi_polynomial, an Octave code which evaluates the Jacobi polynomial and associated functions.
  1001. jacobi_polynomial_test
  1002. jacobi_rule, an Octave code which computes and writes out a Gauss-Jacobi quadrature rule of given order.
  1003. jacobi_rule_test
  1004. jai_alai_simulation, an Octave code which simulates matches of jai alai.
  1005. jai_alai_simulation_test
  1006. jordan_matrix, an Octave code which returns a random matrix in Jordan canonical form.
  1007. jordan_matrix_test
  1008. julia_set, an Octave code which computes and plots a Julia set, the set of points in the complex plane that remain bounded under a mapping of the form f(z) = z^2+c.
  1009. julia_set_test
  1010. kdv_etdrk4, an Octave code which uses the ETDRK4 method to solve the Korteweg-deVries (KdV) partial differential equation (PDE), by Aly-Khan Kassam, Lloyd Trefethen.
  1011. kdv_etdrk4_test
  1012. kdv_exact, an Octave code which evaluates an exact solution of the Korteweg-deVries (KdV) partial differential equation (PDE).
  1013. kdv_exact_test
  1014. kdv_ift, an Octave code which uses the Inverse Fourier Transform (IFT) method to solve the Korteweg-deVries (KdV) partial differential equation (PDE), by Aly-Khan Kassam, Lloyd Trefethen.
  1015. kdv_ift_test
  1016. kelley, an Octave code which implements iterative methods for linear and nonlinear problems, including Arnoldi iteration, Broyden's method, conjugate gradient, GMRES, Krylov iteration, Newton-Krylov nonlinear solver, line search for minimization, transpose-free quasi-minimal residual solver for sparse linear systems, by Tim Kelley.
  1017. kelley_test
  1018. kepler_ode, an Octave code which sets up and solves the ordinary differential equations (ODE) for a Kepler two-body gravitational system.
  1019. kepler_ode_test
  1020. kepler_perturbed_ode, an Octave code which sets up and solves the ordinary differential equations (ODE) for a perturbed Kepler two-body gravitational system.
  1021. kepler_perturbed_ode_test
  1022. keyword_test, an Octave code which accepts named keywords, using the Name/Value paired argument convention.
  1023. kmeans, an Octave code which handles the K-Means problem, which organizes a set of N points in M dimensions into K clusters;
  1024. kmeans_test
  1025. kmeans_fast, an Octave code which contains several different algorithms for the K-Means problem, which organizes a set of N points in M dimensions into K clusters, by Charles Elkan.
  1026. kmeans_fast_test
  1027. knapsack_01_brute, an Octave code which uses brute force to solve small versions of the 0/1 knapsack problem;
  1028. knapsack_01_brute_test
  1029. knapsack_dynamic, an Octave code which uses dynamic programming to solve a knapsack problem.
  1030. knapsack_dynamic_test
  1031. knapsack_greedy, an Octave code which uses a greedy algorithm to estimate a solution of the knapsack problem;
  1032. knapsack_greedy_test
  1033. kronrod_rule, an Octave code which computes a Gauss and Gauss-Kronrod pair of quadrature rules of arbitrary order, by Robert Piessens, Maria Branders.
  1034. kronrod_rule_test
  1035. lagrange_approx_1d, an Octave code which defines and evaluates the Lagrange polynomial p(x) of degree m which approximates a set of nd data points (x(i),y(i)).
  1036. lagrange_approx_1d_test
  1037. lagrange_basis_display, an Octave code which displays the basis functions associated with a given set of nodes used with the Lagrange interpolation scheme.
  1038. lagrange_basis_display_test
  1039. lagrange_interp_1d, an Octave code which defines and evaluates the Lagrange polynomial p(x) which interpolates a set of data depending on a 1D argument, so that p(x(i)) = y(i).
  1040. lagrange_interp_1d_test
  1041. lagrange_interp_2d, an Octave code which defines and evaluates the Lagrange polynomial p(x,y) which interpolates a set of data depending on a 2D argument that was evaluated on a product grid, so that p(x(i),y(j)) = z(i,j).
  1042. lagrange_interp_2d_test
  1043. lagrange_interp_nd, an Octave code which defines and evaluates the Lagrange polynomial p(x) which interpolates a set of data depending on an M dimensional argument that was evaluated on a product grid, so that p(x(i)) = z(i).
  1044. lagrange_interp_nd_test
  1045. lagrange_nd, an Octave code which implements several multivariate Lagrange interpolation schemes developed by Tomas Sauer.
  1046. lagrange_nd_test
  1047. laguerre_exactness, an Octave code which tests the polynomial exactness of Gauss-Laguerre quadrature rules for integrating functions with density exp(-x) over [0,+oo).
  1048. laguerre_exactness_test
  1049. laguerre_integrands, an Octave code which implements test problems for approximate integration over a semi-infinite interval, often carried out using Gauss-Laguerre quadrature.
  1050. laguerre_integrands_test
  1051. laguerre_polynomial, an Octave code which evaluates the Laguerre polynomial, the generalized Laguerre polynomials, and the Laguerre function.
  1052. laguerre_polynomial_test
  1053. laguerre_product, an Octave code which computes weighted integrals of products of Laguerre polynomials.
  1054. laguerre_product_test
  1055. laguerre_rule, an Octave code which computes and prints a Gauss-Laguerre quadrature rule of a given order for estimating the integral of a function with density exp(-x) over the interval [0,+oo).
  1056. laguerre_rule_test
  1057. lambert_w, an Octave code which evaluates Lambert's W function.
  1058. lambert_w_test
  1059. langford_ode, an Octave code which sets up and solves the Langford system of ordinary differential equations (ODE).
  1060. langford_ode_test
  1061. laplace_periodic_test, an Octave code which plots data from the solution of the Laplace equation in a square with periodic boundary conditions, computed by FreeFem++() and transferred using the ffmatlib() library.
  1062. laplacian, an Octave code which carries out computations related to the discrete Laplacian operator, including full or sparse evaluation, evaluation for unequally spaced data sampling points, application to a set of data samples, solution of associated linear systems, eigenvalues and eigenvectors, and extension to 2D and 3D geometry.
  1063. laplacian_test
  1064. latin_center, an Octave code which computes N points in an M dimensional Latin Center square;
  1065. latin_center_test
  1066. latin_cover, an Octave code which produces N Latin squares which cover an NxN square, or NxN Latin cubes which cover an NxNxN cube.
  1067. latin_cover_test
  1068. latin_edge, an Octave code which returns N points in an M dimensional Latin Edge square;
  1069. latin_edge_test
  1070. latin_random, an Octave code which returns N points in an M dimensional Latin Random square;
  1071. latin_random_test
  1072. latinize, an Octave code which adjusts N points in M dimensions to form a Latin hypercube;
  1073. latinize_test
  1074. lattice_rule, an Octave code which returns lattice rules for M dimensional integration;
  1075. lattice_rule_test
  1076. leapfrog, an Octave code which uses the leapfrog method to solve a second order ordinary differential equation (ODE) of the form y''=f(t,y).
  1077. leapfrog_test
  1078. least_squares_approximant, an Octave code which finds a polynomial approximant to data using linear least squares (LLS).
  1079. least_squares_approximant_test
  1080. lebesgue, an Octave code which is given nodes in 1D, plots the Lebesgue function, and estimates the Lebesgue constant, which measures the maximum magnitude of the potential error of Lagrange polynomial interpolation.
  1081. lebesgue_test
  1082. legendre_exactness, an Octave code which tests the monomial exactness of quadrature rules for the Legendre problem of integrating a function with density 1 over the interval [-1,+1].
  1083. legendre_exactness_test
  1084. legendre_fast_rule, an Octave code which uses a fast (order N) algorithm to compute a Gauss-Legendre quadrature rule of given order.
  1085. legendre_fast_rule_test
  1086. legendre_polynomial, an Octave code which evaluates the Legendre polynomial and associated functions.
  1087. legendre_polynomial_test
  1088. legendre_product, an Octave code which computes weighted integrals of products of Legendre polynomials.
  1089. legendre_product_test
  1090. legendre_product_display, an Octave code which displays the points used in a 2D Gauss-Legendre quadrature rule;
  1091. legendre_product_display_test
  1092. legendre_product_polynomial, an Octave code which defines Legendre product polynomials, creating a multivariate polynomial as the product of univariate Legendre polynomials.
  1093. legendre_product_polynomial_test
  1094. legendre_rule, an Octave code which writes out a Gauss-Legendre quadrature rule of given order.
  1095. legendre_rule_test
  1096. legendre_shifted_polynomial, an Octave code which evaluates the shifted Legendre polynomial, with the domain [0,1].
  1097. legendre_shifted_polynomial_test
  1098. levenshtein_distance, an Octave code which returns the Levenshtein distance between two strings.
  1099. levenshtein_distance_test
  1100. levenshtein_matrix, an Octave code which returns the Levenshtein distance matrix defined by two strings.
  1101. levenshtein_matrix_test
  1102. lindberg_ode, an Octave code which sets up and solves a system of 4 ordinary differential equations (ODE) which are very stiff.
  1103. lindberg_ode_test
  1104. line_cvt_lloyd, an Octave code which applies the Lloyd iteration repeatedly to a set of N points, to compute a Centroidal Voronoi Tessellation (CVT) over the interior of a line segment in 1D.
  1105. line_cvt_lloyd_test
  1106. line_distance, an Octave code which computes the expected value of the distance between a pair of points randomly selected in the unit line segment.
  1107. line_distance_test
  1108. line_fekete_rule, an Octave code which estimates the location of N Fekete points, for polynomial interpolation or quadrature, over the interior of a line segment in 1D.
  1109. line_fekete_rule_test
  1110. line_felippa_rule, an Octave code which returns a Felippa quadrature rules for approximating integrals over the interior of a line segment in 1D.
  1111. line_felippa_rule_test
  1112. line_grid, an Octave code which computes a grid of points over the interior of a line segment in 1D.
  1113. line_grid_test
  1114. line_integrals, an Octave code which returns the exact value of the integral of any monomial over the length of the unit line in 1D.
  1115. line_integrals_test
  1116. line_monte_carlo, an Octave code which applies a Monte Carlo method to estimate the integral of a function over the length of the unit line in 1D.
  1117. line_monte_carlo_test
  1118. line_ncc_rule, an Octave code which computes a Newton Cotes Closed (NCC) quadrature rule, using equally spaced points, over the interior of a line segment in 1D.
  1119. line_ncc_rule_test
  1120. line_nco_rule, an Octave code which computes a Newton Cotes Open (NCO) quadrature rule, using equally spaced points, over the interior of a line segment in 1D.
  1121. line_nco_rule_test
  1122. lissajous, an Octave code which plots a Lissajous figure, of the form x = sin ( a1 t + b1 ), y = sin ( a2 t + b2 ).
  1123. lissajous_test
  1124. llsq, an Octave code which solves the linear least squares (LLS) problem. It finds the "best" straight line to match a set of data points. More precisely, it finds the quantities "a" and "b" defining the straight line y=a*x+b, which minimizes the root-mean-square (RMS) error to the data.
  1125. llsq_test
  1126. load_test, an Octave code which calls the load() function, which reads data from a file into a variable.
  1127. lobatto_polynomial, an Octave code which evaluates Lobatto polynomials similar to Legendre polynomials except that they are 0 at both endpoints.
  1128. lobatto_polynomial_test
  1129. local_min, an Octave code which finds a local minimum of a scalar function of a scalar variable, without the use of derivative information, by Richard Brent.
  1130. local_min_test
  1131. local_min_rc, an Octave code which finds a local minimum of a scalar function of a scalar variable, without the use of derivative information, using reverse communication (RC), by Richard Brent.
  1132. local_min_rc_test
  1133. locker_simulation, an Octave code which simulates the locker problem, in which gym users have left their wallets in lockers; someone has scrambled all the lockers, and the gym users need a strategy that maximizes the chance that everyone will find their wallet by searching a limited number of lockers.
  1134. locker_simulation_test
  1135. log_norm, an Octave code which computes the logarithmic norm of a matrix, for norms 1, 2 and oo.
  1136. log_norm_test
  1137. log_normal, an Octave code which returns quantities related to the log normal Probability Distribution Function (PDF).
  1138. log_normal_test
  1139. log_normal_truncated_ab, an Octave code which returns quantities related to the log normal Probability Distribution Function (PDF) truncated to the interval [a,b].
  1140. log_normal_truncated_ab_test
  1141. logistic_bifurcation, an Octave code which plots the bifurcation diagram for the logistic equation, by John D Cook.
  1142. logistic_bifurcation_test
  1143. logistic_ode, an Octave code which sets up and solves an ordinary differential equation (ODE) which models population growth in the face of a limited carrying capacity.
  1144. logistic_ode_test
  1145. lorenz_ode, an Octave code which sets up and solves the Lorenz system of ordinary differential equations (ODE).
  1146. lorenz_ode_test
  1147. luhn, an Octave code which computes the Luhn check digit for a string, and validates a string.
  1148. luhn_test
  1149. machar, an Octave code which computes the appropriate values of arithmetic constants for a given machine, by William Cody.
  1150. machar_test
  1151. machine, an Octave code which returns values of arithmetic constants for a given machine.
  1152. machine_test
  1153. magic_matrix, an Octave code which computes a magic matrix, for any odd order n, such that all rows and columns have the same sum.
  1154. magic_matrix_test
  1155. mandelbrot, an Octave code which generates an image of the Mandelbrot set;
  1156. mandelbrot_test
  1157. mandelbrot_orbit, an Octave code which generates the Mandelbrot iterates arising from a single starting point;
  1158. mandelbrot_orbit_test
  1159. maple_area, an Octave code which takes the list of pixels that form the boundary of the image of a maple leaf within a picture, and uses grid, Monte Carlo, and Quasi Monte Carlo (QMC) sampling to estimate the area of the leaf.
  1160. maple_area_test
  1161. mario, an Octave code which creates a sort of "needlepoint" image of Mario, as an array of colored squares.
  1162. mario_test
  1163. markov_letters, an Octave code which counts the occurences of letter pairs in a text.
  1164. markov_letters_test
  1165. matrix_analyze, an Octave code which reports whether a matrix has various properties.
  1166. matrix_analyze_test
  1167. matrix_chain_dynamic, an Octave code which finds the cost of the most efficient ordering to use when multiplying a sequence of matrices, using dynamic programming..
  1168. matrix_chain_dynamic_test
  1169. matrix_exponential, an Octave code which computes the exponential of a matrix.
  1170. matrix_exponential_test
  1171. mcnuggets, an Octave code which counts M(N), the number of ways a given number N of Chicken McNuggets can be assembled, given that they are only available in packages of 6, 9, and 20.
  1172. mcnuggets_test
  1173. mcnuggets_diophantine, an Octave code which uses Diophantine methods to find the ways a given number N of Chicken McNuggets can be assembled, given that they are only available in packages of 6, 9, and 20.
  1174. mcnuggets_diophantine_test
  1175. md, an Octave code which carries out a molecular dynamics simulation, and is intended as a starting point for implementing a parallel version.
  1176. md_test
  1177. md_fast, an Octave code which carries out a molecular dynamics simulation; it is a version of md() that has been revised to take advantage of vectorization.
  1178. md_fast_test
  1179. medit_mesh_io, an Octave code which reads or writes medit() MESH files defining a finite element mesh.
  1180. medit_mesh_io_test
  1181. medit_to_fem, an Octave code which reads a medit() MESH file and writes a corresponding pair of node and element files that correspond to the FEM format.
  1182. medit_to_fem_test
  1183. memory, an Octave code which declares and uses a sequence of larger and larger arrays, to see what the memory limits are on a given computer.
  1184. memory_test
  1185. mesh_bandwidth, an Octave code which returns the geometric bandwidth associated with a mesh of elements of any order and in a space of M dimensions.
  1186. mesh_bandwidth_test
  1187. mesh_boundary, an Octave code which is given a mesh of a 2D region, formed by polygonal elements, and determines a sequence of pairs of polygonal vertices that define the boundary of the region.
  1188. mesh_boundary_test
  1189. mesh_display, an Octave code which plots the nodes and elements of a polygonal mesh, with optional numbering.
  1190. mesh_display_test
  1191. mesh_etoe, an Octave code which uses ETOV, the mesh element-to-vertex connectivity, to construct ETOE, the element-to-element connectivity.
  1192. mesh_etoe_test
  1193. mesh_vtoe, an Octave code which uses ETOV, the mesh element-to-vertex connectivity, to construct VTOE, the vertex-to-element connectivity.
  1194. mesh_vtoe_test
  1195. mesh2d, an Octave code which automatically creates a triangular mesh for a given polygonal region, by Darren Engwirda.
  1196. mesh2d_test
  1197. mesh2d_to_medit, an Octave code which accepts the nodes and triangles of a mesh created by mesh2d() and creates a corresponding medit() MESH file.
  1198. mesh2d_to_medit_test
  1199. mesh2d_write, an Octave code which writes mesh2d() node and element data to files.
  1200. mesh2d_write_test
  1201. mgmres, an Octave code which applies the restarted Generalized Minimum Residual (GMRES) algorithm to solve a sparse linear system, using Compressed Row Storage (CRS) or sparse triplet (ST) format, by Lili Ju.
  1202. mgmres_test
  1203. mgs, an Octave code which is an obscure legacy code, which the student is encouraged to study, understand, and document. This example is due to Diane O'Leary.
  1204. mgs_test
  1205. middle_square, an Octave code which implements the middle square algorithm for generating random integers. This is a very early method, attributed to von Neumann, which actually is deeply flawed, with short cycles.
  1206. middle_square_test
  1207. midpoint, an Octave code which solves one or more ordinary differential equations (ODE) using the (implicit) midpoint method.
  1208. midpoint_test
  1209. midpoint_adaptive, an Octave code which solves one or more ordinary differential equations (ODE) using the (implicit) midpoint method, with fsolve() solving the implicit equation, and an adaptive time step.
  1210. midpoint_adaptive_test
  1211. midpoint_explicit, an Octave code which solves one or more ordinary differential equations (ODE) using the (explicit) midpoint method, also called the modified Euler method.
  1212. midpoint_explicit_test
  1213. midpoint_fixed, an Octave code which solves one or more ordinary differential equations (ODE) using the (implicit) midpoint method, using a simple fixed-point iteration to solve the implicit equation.
  1214. midpoint_fixed_test
  1215. mm_io, an Octave code which reads and writes sparse linear systems stored in the Matrix Market (MM) format.
  1216. mm_io_test
  1217. mm_to_hb, an Octave code which reads the sparse matrix information from an Matrix Market (MM) file and writes a corresponding Harwell Boeing (HB) file.
  1218. mm_to_hb_test
  1219. mm_to_msm, an Octave code which reads a Matrix Market (MM) file defining a sparse matrix, and creates a corresponding matrix in MATLAB sparse matrix (MSM) format.
  1220. mm_to_msm_test
  1221. mm_to_st, an Octave code which reads the sparse matrix information from a Matrix Market (MM) file and writes a corresponding Sparse Triplet (ST) file.
  1222. mm_to_st_test
  1223. monoalphabetic, an Octave code which applies a monoalphabetic substitution cipher to a string of text.
  1224. monoalphabetic_test
  1225. monomial, an Octave code which enumerates, lists, ranks, unranks and randomizes multivariate monomials in a space of M dimensions, with total degree less than N, equal to N, or lying within a given range.
  1226. monomial_test
  1227. monomial_symmetrize, an Octave code which symmetrizes the coefficients of equivalent monomials in a polynomial.
  1228. monomial_symmetrize_test
  1229. monomial_value, an Octave code which evaluates a monomial in M dimensions.
  1230. monomial_value_test
  1231. monopoly_matrix, an Octave code which computes the adjacency and transition matrices for the game of Monopoly.
  1232. monopoly_matrix_test
  1233. monty_hall_simulation, an Octave code which simulates the "Let's Make a Deal" game in which Monty Hall has hidden a prize behind one of several doors, and the user wins the prize if the correct door is selected.
  1234. monty_hall_simulation_test
  1235. mortality, an Octave code which processes some sample mortality data.
  1236. mortality_test
  1237. msm_to_hb, an Octave code which writes a MATLAB sparse matrix (MSM) to a Harwell Boeing (HB) file;
  1238. msm_to_hb_test
  1239. msm_to_mm, an Octave code which writes a MATLAB sparse matrix (MSM) to a Matrix Market (MM) file;
  1240. msm_to_mm_test
  1241. msm_to_st, an Octave code which writes a MATLAB sparse matrix (MSM) to a Sparse Triplet (ST) file;
  1242. msm_to_st_test
  1243. mxm, an Octave code which sets up a matrix multiplication problem A=B*C of arbitrary size, and compares the time required for IJK, IKJ, JIK, JKI, KIJ and KJI orderings of the loops.
  1244. mxm_test
  1245. naca, an Octave code which takes the parameters of certain NACA airfoils and returns the coordinates of a sequence of points that outline the wing shape. The shape can be displayed graphically.
  1246. naca_test
  1247. nas, an Octave code which runs the NASA kernel benchmark.
  1248. nas_test
  1249. navier_stokes_2d_exact, an Octave code which evaluates an exact solution to the incompressible time-dependent Navier-Stokes equations (NSE) over an arbitrary domain in 2D.
  1250. navier_stokes_2d_exact_test
  1251. navier_stokes_3d_exact, an Octave code which evaluates an exact solution to the incompressible time-dependent Navier-Stokes equations (NSE) over an arbitrary domain in 3D.
  1252. navier_stokes_3d_exact_test
  1253. navier_stokes_mesh2d, an Octave code which handles meshes for several 2D test problems involving the Navier Stokes equations (NSE) for fluid flow, provided by Leo Rebholz.
  1254. navier_stokes_mesh2d_test
  1255. navier_stokes_mesh3d, an Octave code which handles meshes for several 3D test problems involving the Navier Stokes equations (NSE) for fluid flow, provided by Leo Rebholz.
  1256. navier_stokes_mesh3d_test
  1257. ncm, an Octave code which accompanies the textbook "Numerical Computing with MATLAB", by Cleve Moler, and illustrates algorithms for the 3n+1 problem, blackjack, eigenvalue computations, fast Fourier transforms, Fibonacci numbers, file encryption, the flame differential equation, the fractal fern, the Lorenz differential equation, a membrane partial differential equation, minimization of a scalar function, ordinary differential equations, the pendulum differential equation, piecewise cubic Hermite interpolation, polynomial interpolation, quadrature for approximate integration, random number generation, tridiagonal linear system solution, the singular value decomposition, solution of a nonlinear equation.
  1258. ncm_test
  1259. nearest_interp_1d, an Octave code which interpolates a set of data using a piecewise constant (PWC) interpolant defined by the nearest neighbor criterion.
  1260. nearest_interp_1d_test
  1261. neighbor_risk, an Octave code which records information about neighboring pairs of territories in the game of RISK.
  1262. neighbor_risk_test
  1263. neighbor_states, an Octave code which records information about pairs of US states which are neighbors.
  1264. neighbor_states_test
  1265. neural_network, an Octave code which illustrates the use of neural networks for deep learning, using back propagation and stochastic gradient descent, by Catherine Higham and Desmond Higham.
  1266. neural_network_test
  1267. newton_interp_1d, an Octave code which finds a polynomial interpolant to data using Newton divided differences.
  1268. newton_interp_1d_test
  1269. newton_rc, an Octave code which solves a system of nonlinear equations by Newton's method, using reverse communication (RC).
  1270. newton_rc_test
  1271. niederreiter2, an Octave code which computes the Niederreiter M dimensional Quasi Mont Carlo (QMC) sequence, base 2;
  1272. niederreiter2_test
  1273. nintlib, an Octave code which implements approximate integration (quadrature) in M dimensions;
  1274. nintlib_test
  1275. normal01_multivariate_distance, an Octave code which computes the expected value of the distance between a pair of points randomly selected from an isotropic standard normal distribution in M dimensions.
  1276. normal01_multivariate_distance_test
  1277. normal, an Octave code which implements normal random number generators (RNG) for real and complex arithmetic, for scalars, vectors, and matrices.
  1278. normal_test
  1279. normal_ode, an Octave code which sets up and solves an ordinary differential equation (ODE) defining the normal probability density function (PDF).
  1280. normal_ode_test
  1281. numgrid, an Octave code which defines and numbers a subset of the nodes in a regular nxn grid of the [-1,+1]x[-1,+1] unit square.
  1282. numgrid_test
  1283. obj_display, an Octave code which displays an OBJ 3D graphics file;
  1284. obj_display_test
  1285. obj_io, an Octave code which reads and writes the data in an OBJ 3D graphics file;
  1286. obj_io_test
  1287. obj_to_tri_surface, an Octave code which reads an OBJ 3D graphics file and extracts the surface mesh data as a TRI_SURFACE dataset.
  1288. obj_to_tri_surface_test
  1289. octave_combinatorics, an Octave code which considers a variety of problems in combinatorics involving counting, combinations, permutations, and so on.
  1290. octave_distance, an Octave code which estimates the typical distance between a pair of points randomly selected from the surface or interior of a geometric object such as a circle, disk, sphere, cube.
  1291. octave_grid, an Octave code which generates a regular grid of points inside a variety of regions in one, two, three or many dimensions.
  1292. octave_monte_carlo, an Octave code which uses Monte Carlo sampling to estimate areas and integrals.
  1293. octave_ode, an Octave code which sets up various systems of ordinary differential equations (ODE).
  1294. octave_plots, an Octave code which uses plotting to illustrate a mathematical structure, such as an iterative map, a fractal, a curve or surface.
  1295. octave_polynomial, an Octave code which analyzes a variety of polynomial families, returning the polynomial values, coefficients, derivatives, integrals, roots, or other information.
  1296. octave_simulation, an Octave code which uses simulation to study card games, contests, and other processes which have a random element. Usually, the purpose is to try to predict the average behavior of the system over many trials.
  1297. octopus, an Octave code which contains some Octave-specific utilities.
  1298. octopus_test
  1299. ode23_test, an Octave code which calls ode23(), which is a built-in function for the adaptive solution of systems of ordinary differential equations (ODE) using a pair of Runge-Kutta solvers of orders 2 and 3.
  1300. ode45_test, an Octave code which calls ode45(), which is a built-in function for the adaptive solution of systems of ordinary differential equations (ODE) using a pair of Runge-Kutta solvers of orders 4 and 5.
  1301. oregonator_ode, an Octave code which sets up and solves the ordinary differential equations (ODE) that define the Oregonator, a model of the Belousov-Zhabotinsky chemical reaction.
  1302. oregonator_ode_test
  1303. ornstein_uhlenbeck, an Octave code which approximates solutions of the Ornstein-Uhlenbeck stochastic differential equation (SDE) using the Euler method, the Euler-Maruyama method, and the Milstein method.
  1304. ornstein_uhlenbeck_test
  1305. oscillator_ode, an Octave code which sets up and solves the highly oscillatory ordinary differential equation (ODE).
  1306. oscillator_ode_test
  1307. owen, an Octave code which evaluates the Owen T function.
  1308. owen_test
  1309. ozone_ode, an Octave code which sets up and solves a stiff system of four ordinary differential equations (ODE) that simulate the daily variation in atmospheric ozone concentration.
  1310. ozone_ode_test
  1311. ozone2_ode, an Octave code which sets up and solves a stiff system of four ordinary differential equations (ODE) that simulate the daily variation in atmospheric ozone concentration. This version of the ozone ODE includes a nitrogen oxide source term.
  1312. ozone2_ode_test
  1313. padua, an Octave code which returns the coordinates of the 2D Padua points, as well as interpolation weights or quadrature weights, and images of the points.
  1314. padua_test
  1315. pagerank, an Octave code which uses the eigenvalue (power method) and surfer (Markov Chain Monte Carlo MCMC) approaches to ranking web pages.
  1316. pagerank_test
  1317. pagerank2, an Octave code which considers a specific application of the page rank algorithm.
  1318. pagerank2_test
  1319. pariomino, an Octave code which considers pariominoes, which are polyominoes with a checkerboard parity.
  1320. pariomino_test
  1321. partial_digest, an Octave code which seeks solutions of the partial digest problem.
  1322. partial_digest_test
  1323. partition_brute, an Octave code which uses a brute force algorithm to seek solutions of the partition problem, splitting a set of integers into two subsets with equal sum.
  1324. partition_brute_test
  1325. partition_greedy, an Octave code which uses a greedy algorithm to seek a solution of the partition problem, in which a given set of integers is to be split into two groups whose sums are as close as possible.
  1326. partition_greedy_test
  1327. patterson_rule, an Octave code which returns the points and weights of a 1D Gauss-Patterson quadrature rule of order 1, 3, 7, 15, 31, 63, 127, 255 or 511.
  1328. patterson_rule_test
  1329. pbma_io, an Octave code which reads or writes graphics files that use the ASCII Portable Bit Map (PBM) format.
  1330. pbma_io_test
  1331. pce_burgers, an Octave code which solves a version of the time-dependent viscous Burgers equation, with uncertain viscosity, using a polynomial chaos expansion (PCE) in terms of Hermite polynomials, by Gianluca Iaccarino.
  1332. pce_burgers_test
  1333. pce_legendre, an Octave code which sets up the system matrix for a polynomial chaos expansion (PCE), using Legendre polynomials with a linear factor, applied to a 2D partial differential equation (PDE) with a stochastic diffusion coefficient.
  1334. pce_legendre_test
  1335. pce_ode_hermite, an Octave code which sets up a simple scalar ordinary differential equation (ODE) for exponential decay with an uncertain decay rate, using a polynomial chaos expansion (PCE) in terms of Hermite polynomials.
  1336. pce_ode_hermite_test
  1337. pdflib, an Octave code which evaluates Probability Density Functions (PDF) and produces random samples from them, including beta, binomial, chi, exponential, gamma, inverse chi, inverse gamma, multinomial, normal, scaled inverse chi, and uniform.
  1338. pdflib_test
  1339. pendulum_comparison_ode, an Octave code which compares the linear and nonlinear ordinary differential equations (ODE) that represent the behavior of a pendulum of length L under a gravitational force of strength G.
  1340. pendulum_comparison_ode_test
  1341. pendulum_double_ode, an Octave code which sets up and solves the double pendulum ordinary differential equation (ODE).
  1342. pendulum_double_ode_test
  1343. pendulum_elastic_ode an Octave code which sets up and solves the ordinary differential equations (ODE) that represent the behavior of a nonlinear elastic pendulum, with gravitational force G, spring constant K, unstretched length L, and mass M.
  1344. pendulum_elastic_ode_test
  1345. pendulum_nonlinear_exact, an Octave code which evaluates an exact formula for the solution of the the ordinary differential equations (ODE) that represent the behavior of a nonlinear pendulum of length L under a gravitational force of strength G.
  1346. pendulum_nonlinear_exact_test
  1347. pendulum_nonlinear_ode, an Octave code which sets up and solves the ordinary differential equations (ODE) that represent a nonlinear model of the behavior of a pendulum of length L under a gravitational force of strength G.
  1348. pendulum_nonlinear_ode_test
  1349. pendulum_ode, an Octave code which sets up and solves the ordinary differential equations (ODE) that represent a linear model of the behavior of a pendulum of length L under a gravitational force of strength G.
  1350. pendulum_ode_test
  1351. pendulum_ode_period, an Octave code which sets up and solves a system of ordinary differential equations (ODE) that represent the behavior of a linear pendulum of length L under a gravitational force of strength G, in order to estimate the period of oscillation.
  1352. pendulum_ode_period_test
  1353. pentominoes, an Octave code which forms or plots any of the 12 members of the pentomino family, shapes formed from 5 adjacent squares.
  1354. pentominoes_test
  1355. perceptron_test, an Octave code which calculates a classifier of linearly separable data using the perceptron algorithm.
  1356. percolation_simulation, an Octave code which simulates a percolation system. A rectangular region is decomposed into a grid of MxN squares. Each square may be porous or solid. We are interested in a path of porous squares connecting the top and bottom, or the left and right boundaries. The original code was written by Ian Cooper.
  1357. percolation_simulation_test
  1358. permutation_distance, an Octave code which estimates the expected value of the Ulam distance between a pair of randomly selected permutations of the same order.
  1359. permutation_distance_test
  1360. persistence, an Octave code which demonstrates how to initialize, get, or set data stored within a function, using static/persistent/saved/local memory.
  1361. persistence_test
  1362. pgma_io, an Octave code which reads or writes graphics files that use the ASCII Portable Gray Map (PGM) format.
  1363. pgma_io_test
  1364. pi_spigot, an Octave code which produces any number of digits of the decimal expansion of pi.
  1365. pi_spigot_test
  1366. pic, an Octave code which uses the Particle In Cell (PIC) method to simulate the motion of electrically charged particles past a plate, and is intended as a starting point for implementing a parallel version.
  1367. pic_test
  1368. pink_noise, an Octave code which computes a pink noise signal obeying a 1/f power law.
  1369. pink_noise_test
  1370. plasma_matrix, an Octave code which sets up a matrix associated with a problem in plasma physics.
  1371. plasma_matrix_test
  1372. poisson_1d_multigrid, an Octave code which applies the multigrid method to a discretized version of the 1D Poisson equation.
  1373. poisson_1d_multigrid_test
  1374. poisson_2d, an Octave code which solves the Poisson equation in a rectangle, using finite differences and Jacobi iteration.
  1375. poisson_2d_test
  1376. poisson_ell_test, an Octave code which plots data from a solution of the Poisson equation in the L-shaped region, as computed by FreeFem++() and transferred using the ffmatlib() library.
  1377. poisson_simulation, an Octave code which simulates a Poisson process in which events randomly occur with an average waiting time of Lambda.
  1378. poisson_simulation_test
  1379. polar_ode, an Octave code which sets up and solves an ordinary differential equation (ODE) whose variable is complex, and whose solution should be viewed in a polar coordinate plot.
  1380. polar_ode_test
  1381. polpak, an Octave code which evaluates a variety of mathematical functions, polynomials, and sequences, including Bell, Benford, Bernoulli, Bernstein, Cardan, Catalan, Charlier, Chebyshev, Collatz, Delannoy, Euler, Fibonacci, Gegenbauer, Gudermannian, Harmonic, Hermite, Hofstadter, Jacobi, Krawtchouk, Laguerre, Lambert, Legendre, Lerch, Meixner, Mertens, Moebius, Motzkin, Phi, Stirling, Tau, Tribonacci, Zernike.
  1382. polpak_test
  1383. polygon, an Octave code which computes properties of an arbitrary polygon in the plane, defined by a sequence of vertices, including interior angles, area, centroid, containment of a point, convexity, counter clockwise ordering, diameter, distance to a point, inradius, lattice area, nearest point in set, outradius, uniform sampling, and triangulation.
  1384. polygon_test
  1385. polygon_average, an Octave code which demonstrates a process of repeatedly averaging and normalizing the vertices of a polygon, illustrating a property of the power method.
  1386. polygon_average_test
  1387. polygon_distance, an Octave code which computes the expected value of the distance between a pair of points randomly selected from the interior of a polygon in 2D.
  1388. polygon_distance_test
  1389. polygon_grid, an Octave code which generates a grid of points over the interior of a polygon in 2D.
  1390. polygon_grid_test
  1391. polygon_integrals, an Octave code which returns the exact value of the integral of any monomial over the interior of a polygon in 2D.
  1392. polygon_integrals_test
  1393. polygon_monte_carlo, an Octave code which applies a Monte Carlo method to estimate the integral of a function over the interior of a polygon in 2D.
  1394. polygon_monte_carlo_test
  1395. polygon_triangulate, an Octave code which triangulates a (possibly nonconvex) polygon in 2D, based on a C program by Joseph ORourke;
  1396. polygon_triangulate_test
  1397. polyiamonds, an Octave code which works with polyiamonds, simple shapes constructed by edgewise connections of congruent equilateral triangles.
  1398. polyiamonds_test
  1399. polynomial, an Octave code which adds, multiplies, differentiates, evaluates and prints multivariate polynomials in a space of M dimensions.
  1400. polynomial_test
  1401. polynomial_conversion, an Octave code which converts representations of a polynomial between monomial, Bernstein, Chebyshev, Gegenbauer, Hermite, Laguerre and Legendre forms.
  1402. polynomial_conversion_test
  1403. polynomial_multiply, an Octave code which multiplies two polynomials p(x) and q(x).
  1404. polynomial_multiply_test
  1405. polynomial_resultant, an Octave code which computes the resultant R of univariate polynomials P and Q.
  1406. polynomial_resultant_test
  1407. polynomial_root_bound, an Octave code which computes the Cauchy bound on the magnitude of all roots of a polynomial with complex coefficients.
  1408. polynomial_root_bound_test
  1409. polynomials, an Octave code which defines multivariate polynomials over rectangular domains, for which certain information is to be determined, such as the maximum and minimum values.
  1410. polynomials_test
  1411. polyomino_parity, an Octave code which uses parity considerations to determine whether a given set of polyominoes can tile a specified region.
  1412. polyomino_parity_test
  1413. polyominoes, an Octave code which defines, solves, and plots a variety of polyomino tiling problems, which are solved by a direct algebraic approach, instead of the more typical brute-force or backtracking methods.
  1414. polyominoes_test
  1415. power_method, an Octave code which carries out the power method for finding a dominant eigenvalue and its eigenvector.
  1416. power_method_test
  1417. power_rule, an Octave code which constructs a power rule, that is, a product quadrature rule from identical 1D factor rules.
  1418. power_rule_test
  1419. ppma_io, an Octave code which reads or writes graphics files that use the ASCII Portable Pixel Map (PPM) format.
  1420. ppma_io_test
  1421. praxis, an Octave code which minimizes a scalar function of several variables, without requiring derivative information, by Richard Brent.
  1422. praxis_test
  1423. predator_prey_ode, an Octave code which sets up and solves a time-dependent predator-prey system of ordinary differential equations (ODE).
  1424. predator_prey_ode_test
  1425. predator_prey_ode_period, an Octave code which sets up and solves a time-dependent predator-prey system of ordinary differential equations (ODE) in order to estimate the period of the limit cycle.
  1426. predator_prey_ode_period_test
  1427. prime, an Octave code which counts the number of primes between 1 and N, and is intended as a starting point for a parallel version.
  1428. prime_test
  1429. prime_pi, an Octave code which evaluates Pi(n), the number of primes less than or equal to an integer n.
  1430. prime_pi_test
  1431. prime_plot, an Octave code which displays a box plot of the prime and composite numbers.
  1432. prime_plot_test
  1433. prism_jaskowiec_rule, an Octave code which returns symmetric quadrature rules, with exactness up to total degree 20, over the interior of a prism with triangular base, by Jan Jaskowiec, Natarajan Sukumar.
  1434. prism_jaskowiec_rule_test
  1435. prism_witherden_rule, an Octave code which returns a symmetric Witherden quadrature rule for a prism with triangular base, with exactness up to total degree 10.
  1436. prism_witherden_rule_test
  1437. prob, an Octave code which evaluates, samples, inverts, and characterizes Probability Density Functions (PDF) and Cumulative Density Functions (CDF), including anglit, arcsin, benford, birthday, bernoulli, beta_binomial, beta, binomial, bradford, burr, cardiod, cauchy, chi, chi squared, circular, cosine, deranged, dipole, dirichlet mixture, discrete, empirical, english sentence and word length, error, exponential, extreme values, f, fisk, folded normal, frechet, gamma, generalized logistic, geometric, gompertz, gumbel, half normal, hypergeometric, inverse gaussian, laplace, levy, logistic, log normal, log series, log uniform, lorentz, maxwell, multinomial, nakagami, negative binomial, normal, pareto, planck, poisson, power, quasigeometric, rayleigh, reciprocal, runs, sech, semicircular, student t, triangle, uniform, von mises, weibull, zipf.
  1438. prob_test
  1439. product_rule, an Octave code which creates an M dimensional quadrature rule from a product of distinct 1d quadrature rules;
  1440. product_rule_test
  1441. pwc_plot_1d, an Octave code which converts the definition of a piecewise constant (PWC) function of a 1D argument into plottable data.
  1442. pwc_plot_1d_test
  1443. pwc_plot_2d, an Octave code which converts the definition of a piecewise constant (PWC) function of a 2D argument into plottable data.
  1444. pwc_plot_2d_test
  1445. pwl_approx_1d, an Octave code which approximates a set of data using a piecewise linear (PWL) function.
  1446. pwl_approx_1d_test
  1447. pwl_interp_1d, an Octave code which interpolates a set of data using a piecewise linear (PWL) function.
  1448. pwl_interp_1d_test
  1449. pwl_interp_2d, an Octave code which evaluates a piecewise linear (PWL) interpolant to data defined on a regular 2D grid.
  1450. pwl_interp_2d_test
  1451. pwl_interp_2d_scattered, an Octave code which evaluates a piecewise linear (PWL) interpolant to data which is available at an irregularly arranged set of points.
  1452. pwl_interp_2d_scattered_test
  1453. pwl_product_integral, an Octave code which calculates the exact value of the integral of the product of two piecewise linear (PWL) functions f(x) and g(x).
  1454. pwl_product_integral_test
  1455. pyramid_exactness, an Octave code which investigates the polynomial exactness of a quadrature rule over the interior of the unit pyramid in 3D.
  1456. pyramid_exactness_test
  1457. pyramid_felippa_rule, an Octave code which returns a Felippa quadrature rule for approximating integrals over the interior of a pyramid in 3D.
  1458. pyramid_felippa_rule_test
  1459. pyramid_grid, an Octave code which computes a grid of points over the interior of the unit pyramid in 3D;
  1460. pyramid_grid_test
  1461. pyramid_integrals, an Octave code which returns the exact value of the integral of any monomial over the interior of the unit pyramid in 3D.
  1462. pyramid_integrals_test
  1463. pyramid_jaskowiec_rule, an Octave code which returns quadrature rules, with exactness up to total degree 20, over the interior of a pyramid in 3D, by Jan Jaskowiec, Natarajan Sukumar.
  1464. pyramid_jaskowiec_rule_test
  1465. pyramid_monte_carlo, an Octave code which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit pyramid in 3D;
  1466. pyramid_monte_carlo_test
  1467. pyramid_rule, an Octave code which computes a conical product quadrature rule over the interior of the unit pyramid in 3D.
  1468. pyramid_rule_test
  1469. pyramid_witherden_rule, an Octave code which returns a Witherden quadrature rule, with exactness up to total degree 10, over the interior of a pyramid.
  1470. pyramid_witherden_rule_test
  1471. qr_solve, an Octave code which computes the linear least squares (LLS) solution of a system A*x=b using the QR factorization.
  1472. qr_solve_test
  1473. quad_fast_rule, an Octave code which rapidly defines certain quadrature rules for approximating an integral;
  1474. quad_fast_rule_test
  1475. quad_rule, an Octave code which defines quadrature rules for approximating an integral;
  1476. quad_rule_test
  1477. quad2d, an Octave code which estimates an integral over a 2D rectangle using quadrature, intended as the starting point for program optimization or parallelization.
  1478. quad2d_test
  1479. quadex_ode an Octave code which sets up and solves a stiff ordinary differential equation (ODE), whose exact solution is a parabola, but for which errors grow exponentially.
  1480. quadex_ode_test
  1481. quadmom, an Octave code which computes a Gaussian quadrature rule for a weight function rho(x) based on the Golub-Welsch procedure that only requires knowledge of the moments of rho(x).
  1482. quadmom_test
  1483. quadrature_golub_welsch, an Octave code which computes the points and weights of a Gaussian quadrature rule using the Golub-Welsch procedure.
  1484. quadrature_golub_welsch_test
  1485. quadrature_least_squares, an Octave code which computes weights for sub-interpolatory quadrature rules, that is, it estimates integrals by integrating a polynomial that approximates the function data in a least squares sense.
  1486. quadrature_least_squares_test
  1487. quadrature_weights_vandermonde, an Octave code which computes the weights of a quadrature rule using the Vandermonde matrix, assuming that the points have been specified.
  1488. quadrature_weights_vandermonde_test
  1489. quadrature_weights_vandermonde_2d, an Octave code which computes the weights of a 2D quadrature rule using the Vandermonde matrix, assuming that the points have been specified.
  1490. quadrature_weights_vandermonde_2d_test
  1491. quadrilateral, an Octave code which carries out geometric calculations on quadrilaterals, including angles, area, distances, nearest point, point containment, perimeter, and random generation.
  1492. quadrilateral_test
  1493. quadrilateral_mesh, an Octave code which handles meshes of quadrilaterals over a 2D region;
  1494. quadrilateral_mesh_test
  1495. quadrilateral_mesh_order1_display, an Octave code which plots piecewise constant (PWC) data associated with a mesh of quadrilaterals;
  1496. quadrilateral_mesh_order1_display_test
  1497. quadrilateral_surface_display, an Octave code which plots piecewise bilinear data associated with a quadrilateral_surface, that is, a 3D surface defined by a quadrilateral mesh;
  1498. quadrilateral_surface_display_test
  1499. quadrilateral_witherden_rule, an Octave code which returns a symmetric Witherden quadrature rule for the quadrilateral, with exactness up to total degree 21.
  1500. quadrilateral_witherden_rule_test
  1501. quality, an Octave code which measures the dispersion of pointsets in M dimensions;
  1502. quality_test
  1503. quasiperiodic_ode, an Octave code which sets up and solves a system of ordinary differential equations (ODE) for a problem with a quasiperiodic solution.
  1504. quasiperiodic_ode_test
  1505. quaternions, an Octave code which carries out some simple arithmetic operations for quaternions.
  1506. quaternions_test
  1507. r8_scale, an Octave code which computes the "next" and "previous" real numbers.
  1508. r8_scale_test
  1509. r83, an Octave code which contains linear algebra routines for r83 matrices (real, 64 bit, tridiagonal 3xN format).
  1510. r83_test
  1511. r83_np, an Octave code which contains linear algebra routines for r83_np matrices (real, 64 bit, tridiagonal 3xN format, nonpivoting factorization).
  1512. r83_np_test
  1513. r83p, an Octave code which contains linear algebra routines for r83p matrices (real, 64 bit, tridiagonal periodic format).
  1514. r83p_test
  1515. r83s, an Octave code which contains linear algebra routines for r83s matrices (real, 64 bit, tridiagonal scalar format).
  1516. r83s_test
  1517. r83t, an Octave code which contains linear algebra routines for r83t matrices (real, 64 bit, tridiagonal Mx3 format).
  1518. r83t_test
  1519. r83v, an Octave code which contains linear algebra routines for r83v matrices (real, 64 bit, tridiagonal three vector format).
  1520. r83v_test
  1521. r85, an Octave code which contains linear algebra routines for r85 matrices (real, 64 bit, pentadiagonal format).
  1522. r85_test
  1523. r8bb, an Octave code which contains linear algebra routines for r8bb matrices (real, 64 bit, border banded format).
  1524. r8bb_test
  1525. r8blt, an Octave code which contains linear algebra routines for r8blt matrices (real, 64 bit, band lower triangular format).
  1526. r8blt_test
  1527. r8bto, an Octave code which contains linear algebra routines for r8bto matrices (real, 64 bit, block Toeplitz format).
  1528. r8bto_test
  1529. r8but, an Octave code which contains linear algebra routines for r8but matrices (real, 64 bit, band upper triangular format).
  1530. r8but_test
  1531. r8cb, an Octave code which contains linear algebra routines for r8cb matrices (real, 64 bit, Compressed Band format).
  1532. r8cb_test
  1533. r8cbb, an Octave code which contains linear algebra routines for r8cbb matrices (real, 64 bit, Compressed Border Banded format).
  1534. r8cbb_test
  1535. r8ccs, an Octave code which contains linear algebra routines for r8ccs matrices: real, 64 bit, Compressed Column Storage (CCS) format.
  1536. r8ccs_test
  1537. r8ci, an Octave code which contains linear algebra routines for r8ci matrices (real, 64 bit, circulant format).
  1538. r8ci_test
  1539. r8col, an Octave code which contains utility routines for an R8COL, that is, a real 64 bit MxN array, considered as N column vectors, each of length M. The data may be thought of as a matrix of multiple columns, and many operations will be carried out columnwise.
  1540. r8col_test
  1541. r8crs, an Octave code which contains linear algebra routines for R8CRS matrices: real, 64 bit, Compressed Row Storage (CRS) format.
  1542. r8crs_test
  1543. r8gb, an Octave code which contains linear algebra routines for r8gb matrices (real, 64 bit, General Banded format).
  1544. r8gb_test
  1545. r8gd, an Octave code which contains linear algebra routines for r8gd matrices (real, 64 bit, general diagonal format).
  1546. r8gd_test
  1547. r8ge, an Octave code which contains linear algebra routines for R8GE matrices (real, 64 bit, General format).
  1548. r8ge_test
  1549. r8ge_np, an Octave code which contains nonpivoting linear algebra routines for r8ge_np matrices (real, 64 bit, General Nonpivoting format).
  1550. r8ge_np_test
  1551. r8lib, an Octave code which contains many utility routines, using double precision real (R8) arithmetic.
  1552. r8lib_test
  1553. r8lt, an Octave code which contains linear algebra routines for R8LT matrices: real, 64 bit, Lower Triangular.
  1554. r8lt_test
  1555. r8ltt, an Octave code which contains linear algebra routines for r8ltt matrices (real, 64 bit, lower triangular Toeplitz format).
  1556. r8ltt_test
  1557. r8ncf, an Octave code which contains linear algebra routines for r8ncf matrices (real, 64 bit, nonsymmetric coordinate format).
  1558. r8ncf_test
  1559. r8pbl, an Octave code which contains linear algebra routines for r8pbl matrices (real, 64 bit, symmetric positive definite (SPD) band lower format).
  1560. r8pbl_test
  1561. r8pbu, an Octave code which contains linear algebra routines for r8pbu matrices (real, 64 bit, symmetric positive definite (SPD) band upper format).
  1562. r8pbu_test
  1563. r8po, an Octave code which contains linear algebra routines for r8po matrices (real, 64 bit, symmetric positive definite (SPD) format).
  1564. r8po_test
  1565. r8poly, an Octave code which operates on real polynomials, including evaluation, differentiation, integration, multiplication, synthetic division, shifting the base, computing a power, taking the norm. It also defines Chebyshev, Lagrange and Legendre polynomials.
  1566. r8poly_test
  1567. r8pp, an Octave code which contains linear algebra routines for r8pp matrices (real, 64 bit, symmetric positive definite (SPD) packed format).
  1568. r8pp_test
  1569. r8ri, an Octave code which contains linear algebra routines for r8ri matrices (real, 64 bit, row indexed format).
  1570. r8ri_test
  1571. r8row, an Octave code which contains utility routines for an R8ROW, that is, a real 64 bit MxN array, considered as M row vectors, each of length N. The data may be thought of as a matrix of multiple rows, and many operations will be carried out rowwise.
  1572. r8row_test
  1573. r8sd, an Octave code which contains linear algebra routines for r8sd matrices (real, 64 bit, symmetric diagonal format).
  1574. r8sd_test
  1575. r8sm, an Octave code which contains linear algebra routines for r8sm matrices (real, 64 bit, Sherman-Morrison A-u*v' format).
  1576. r8sm_test
  1577. r8sr, an Octave code which carries out linear algebra operations for r8sr matrices (real, 64 bit, diagonal + compressed row offdiagonal format).
  1578. r8sr_test
  1579. r8ss, an Octave code which carries out linear algebra operations for r8ss matrices (real, 64 bit, symmetric skyline format).
  1580. r8ss_test
  1581. r8st, an Octave code which contains linear algebra routines for R8ST matrices: real, 64 bit, Sparse Triplet.
  1582. r8st_test
  1583. r8sto, an Octave code which contains linear algebra routines for r8sto matrices (real, 64 bit, symmetric Toeplitz N format).
  1584. r8sto_test
  1585. r8to, an Octave code which contains linear algebra routines for r8to matrices (real, 64 bit, Toeplitz 2*N-1 format).
  1586. r8to_test
  1587. r8ut, an Octave code which contains linear algebra routines for r8ut matrices: real, 64 bit, Upper Triangular.
  1588. r8ut_test
  1589. r8utp, an Octave code which carries out linear algebra operations on r8utp matrices, real 64 bit, Upper Triangular Packed format.
  1590. r8utp_test
  1591. r8utt, an Octave code which contains linear algebra routines for r8utt matrices (real, 64 bit, upper triangular Toeplitz format).
  1592. r8utt_test
  1593. r8vm, an Octave code which contains linear algebra routines for r8vm matrices (real, 64 bit, vandermonde format).
  1594. r8vm_test
  1595. randlc, an Octave code which implements a random number generator (RNG) used by the nas() benchmarks.
  1596. randlc_test
  1597. random_data, an Octave code which uses a random number generator (RNG) to sample points distributed according to various probability density functions (PDF), spatial dimensions, and geometries, including the annulus, cube, ellipse, ellipsoid, polygon, simplex and sphere.
  1598. random_data_test
  1599. random_sorted, an Octave code which generates vectors of random values which are already sorted.
  1600. random_sorted_test
  1601. random_walk_1d_simulation, an Octave code which simulates a random walk in a 1-dimensional region.
  1602. random_walk_1d_simulation_test
  1603. random_walk_2d_avoid_simulation, an Octave code which simulates a self-avoiding random walk in a 2-dimensional region.
  1604. random_walk_2d_avoid_simulation_test
  1605. random_walk_2d_simulation, an Octave code which simulates a random walk in a 2-dimensional region.
  1606. random_walk_2d_simulation_test
  1607. random_walk_3d_simulation, an Octave code which simulates a random walk in a 3-dimensional region.
  1608. random_walk_3d_simulation_test
  1609. ranlib, an Octave code which produces random samples from Probability Density Functions (PDF), including Beta, Chi-square Exponential, F, Gamma, Multivariate normal, Noncentral chi-square, Noncentral F, Univariate normal, random permutations, Real uniform, Binomial, Negative Binomial, Multinomial, Poisson and Integer uniform, by Barry Brown and James Lovato.
  1610. ranlib_test
  1611. rbf_interp_1d, an Octave code which defines and evaluates radial basis function (RBF) interpolants to 1D data.
  1612. rbf_interp_1d_test
  1613. rbf_interp_2d, an Octave code which defines radial basis function (RBF) interpolants to 2D data.
  1614. rbf_interp_2d_test
  1615. rbf_interp_nd, an Octave code which defines and evaluates radial basis function (RBF) interpolants to M dimensional data.
  1616. rbf_interp_nd_test
  1617. reaction_ode, an Octave code which sets up and solves the ordinary differential equations (ODE) which model a simple chemical reaction A+B --k--> C.
  1618. reaction_ode_test
  1619. reaction_twoway_ode, an Octave code which sets up and solves the ordinary differential equations (ODE) which model a two-way chemical reaction between species W1 and W2.
  1620. reaction_twoway_ode_test
  1621. reactor simulation, an Octave code which is a simple Monte Carlo simulation of the shielding effect of a slab of a certain thickness in front of a neutron source. This program was provided as an example with the book "Numerical Methods and Software."
  1622. reactor simulation_test
  1623. rectangle_distance, an Octave code which estimates the distribution and expected value of the distance between two points picked uniformly at random within a rectangle.
  1624. rectangle_distance_test
  1625. region_test, an Octave code which plots data from an interesting region that was meshed by FreeFem++() and transferred using the ffmatlib() library.
  1626. rejection_sample, an Octave code which demonstrates acceptance/rejection sampling.
  1627. rejection_sample_test
  1628. rigid_body_ode, an Octave code which sets up and solves the ordinary differential equations (ODE) representing the Euler equations for a rigid body with three unequal moments of inertia, originally proposed by Fred Krogh.
  1629. rigid_body_ode_test
  1630. ring_data, an Octave code which creates, plots, or saves data generated by sampling a number of concentric, possibly overlapping rings.
  1631. ring_data_test
  1632. ripple_ode, an Octave code which sets up and solves an ordinary differential equation (ODE) whose solutions start as ripples and end as hyperbolas.
  1633. ripple_ode_test
  1634. risk_matrix, an Octave code which returns the transition and adjacency matrix for the game of RISK.
  1635. risk_matrix_test
  1636. rk12, an Octave code which solves an ordinary differential equation (ODE) using a Runge-Kutta (RK) method of order 2, estimating the local error with a Runge-Kutta method of order 1.
  1637. rk12_test
  1638. rk12_adapt, an Octave code which defines an adaptive ordinary differential equation (ODE) solver, using Runge-Kutta (RK) solvers of order 1 and 2.
  1639. rk12_adapt_test
  1640. rk23, an Octave code which applies Runge-Kutta (RK) solvers of order 2 and 3 to a system of ordinary differential equations (ODE);
  1641. rk23_test
  1642. rk34, an Octave code which applies Runge-Kutta (RK) solvers of order 3 and 4 to a system of ordinary differential equations (ODE);
  1643. rk34_test
  1644. rk4, an Octave code which applies the fourth order Runge-Kutta (RK) algorithm to estimate the solution of an ordinary differential equation (ODE) at the next time step.
  1645. rk4_test
  1646. rk45, an Octave code which applies Runge-Kutta (RK) solvers of order 4 and 5 to a system of ordinary differential equations (ODE);
  1647. rk45_test
  1648. rkf45, an Octave code which applies a Runge-Kutta-Fehlberg (RKF) solver to a system of ordinary differential equations (ODE);
  1649. rkf45_test
  1650. rng_cliff, an Octave code which computes a sequence of values from the Cliff random number generator (RNG).
  1651. rng_cliff_test
  1652. rnglib, an Octave code which implements a random number generator (RNG) with splitting facilities, allowing multiple independent streams to be computed, by L'Ecuyer and Cote.
  1653. rnglib_test
  1654. robertson_ode, an Octave code which sets up and solves a system of three nonlinear stiff ordinary differential equations (ODE) characterizing an autocatalytic chemical reaction.
  1655. robertson_ode_test
  1656. roessler_ode, an Octave code which sets up and solves the 3D Roessler system of ordinary differential equations (ODE).
  1657. roessler_ode_test
  1658. root_rc, an Octave code which seeks a solution of a scalar nonlinear equation f(x)=0, using reverse communication (RC), by Gaston Gonnet.
  1659. root_rc_test
  1660. roots_rc, an Octave code which seeks solutions of a system of nonlinear equations, using reverse communication (RC), by Gaston Gonnet.
  1661. roots_rc_test
  1662. rot13, an Octave code which enciphers a string using the ROT13 cipher for letters, and the ROT5 cipher for digits.
  1663. rot13_test
  1664. roulette_simulation, an Octave code which simulates the spinning of a roulette wheel and the evaluation of certain common roulette bets.
  1665. roulette_simulation_test
  1666. row_echelon_integer, an Octave code which carries out the exact computation of the integer row echelon form (IREF) and integer reduced row echelon form (IRREF) of an integer matrix.
  1667. row_echelon_integer_test
  1668. rref_test, an Octave code which calls rref() for the reduced row echelon form (RREF) of a matrix, which can be singular or rectangular.
  1669. rubber_band_ode, an Octave code which sets up and solves a set of ordinary differential equations (ODE) describing a mass suspended by a spring and rubber band, which can exhibit chaotic behavior.
  1670. rubber_band_ode_test
  1671. rucklidge_ode, an Octave code which sets up and solves the Rucklidge ordinary differential equation (ODE), a model of double convection which embodies a transition to chaos.
  1672. rucklidge_ode_test
  1673. sammon_data, an Octave code which generates six M dimensional datasets for cluster analysis.
  1674. sammon_data_test
  1675. sandia_cubature, an Octave code which computes M-dimensional quadrature rules for certain regions and weight functions.
  1676. sandia_cubature_test
  1677. sandia_rules, an Octave code which produces 1D quadrature rules of Chebyshev, Clenshaw Curtis, Fejer 2, Gegenbauer, generalized Hermite, generalized Laguerre, Hermite, Jacobi, Laguerre, Legendre and Patterson types.
  1678. sandia_rules_test
  1679. sandia_sgmgg, an Octave code which explores a generalized construction method for sparse grids.
  1680. sandia_sgmgg_test
  1681. sandia_sparse, an Octave code which produces a M-dimensional sparse grid, based on a variety of 1D quadrature rules; only isotropic grids are generated, that is, the same rule is used in each dimension, and the same maximum order is used in each dimension.
  1682. sandia_sparse_test
  1683. satisfy_brute, an Octave code which uses brute force to find all assignments of values to a set of logical variables which make a complicated logical statement true.
  1684. satisfy_brute_test
  1685. sawtooth_ode, an Octave code which sets up and solves an ordinary differential equation (ODE) driven by a right hand side which is a sawtooth function (periodic, discontinuous, piecewise linear).
  1686. sawtooth_ode_test
  1687. schroedinger_linear_pde, an Octave code which sets up and solves the complex partial differential equation (PDE) known as Schroedinger's linear equation: dudt = i uxx, in one spatial dimension, with Neumann boundary conditions.
  1688. schroedinger_linear_pde_test
  1689. schroedinger_nonlinear_pde, an Octave code which sets up and solves the complex partial differential equation (PDE) known as Schroedinger's nonlinear equation: dudt = i uxx + i gamma * |u|^2 u, in one spatial dimension, with Neumann boundary conditions.
  1690. schroedinger_nonlinear_pde_test
  1691. scip_solution_read, an Octave code which reads a file created by the integer programming package scip(), representing the solution of a polyomino tiling problem, and writes out a simple ASCII file.
  1692. scip_solution_read_test
  1693. sde, an Octave code which illustrates properties of stochastic differential equations (SDE), and common algorithms for their analysis, by Desmond Higham;
  1694. sde_test
  1695. search_test, an Octave code which searches integers between A and B for a value J such that F(J) = C.
  1696. sensitive_ode, an Octave code which sets up a second order ordinary differential equation (ODE) which exhibits sensitive dependence on the initial condition.
  1697. sensitive_ode_test
  1698. serenity, an Octave code which considers the serenity puzzle, a smaller version of the eternity puzzle. The serenity puzzle specifies a dodecagonal region R composed of 288 30-60-90 triangles, and a set of 8 "tiles", each consisting of 36 30-60-90 triangles, and seeks an arrangement of the tiles that exactly covers the region.
  1699. serenity_test
  1700. serenity_cplex_test a BASH code which calls cplex(), to read the LP file defining the serenity tiling problem, solve the linear programming problem, and write the solution to a file.
  1701. serenity_gurobi_test a BASH code which calls gurobi(), to read the LP file defining the serenity tiling problem, solve the linear programming problem, and write the solution to a file.
  1702. set_theory, an Octave code which implements various set theoretic operations.
  1703. set_theory_test
  1704. sftpack, an Octave code which implements the slow Fourier transform (SFT), intended as a teaching tool and comparison with the Fast Fourier Transform (FFT).
  1705. sftpack_test
  1706. shepard_interp_1d, an Octave code which defines and evaluates Shepard interpolants to 1D data, based on inverse distance weighting.
  1707. shepard_interp_1d_test
  1708. shepard_interp_2d, an Octave code which defines and evaluates Shepard interpolants to 2D data, based on inverse distance weighting.
  1709. shepard_interp_2d_test
  1710. shepard_interp_nd, an Octave code which defines and evaluates Shepard interpolants to M dimensional data, based on inverse distance weighting.
  1711. shepard_interp_nd_test
  1712. simplex_coordinates, an Octave code which computes the Cartesian coordinates of the vertices of a regular simplex in M dimensions.
  1713. simplex_coordinates_test
  1714. simplex_gm_rule, an Octave code which defines Grundmann-Moeller quadrature rules over the interior of a triangle in 2D, a tetrahedron in 3D, or over the interior of the simplex in M dimensions.
  1715. simplex_gm_rule_test
  1716. simplex_grid, an Octave code which generates a regular grid of points over the interior of an arbitrary simplex in M dimensions.
  1717. simplex_grid_test
  1718. simplex_integrals, an Octave code which returns the exact value of the integral of any monomial over the interior of the unit simplex in M dimensions.
  1719. simplex_integrals_test
  1720. simplex_monte_carlo, an Octave code which uses the Monte Carlo method to estimate an integral over the interior of the unit simplex in M dimensions.
  1721. simplex_monte_carlo_test
  1722. sine_transform, an Octave code which demonstrates properties of the discrete sine transform (DST).
  1723. sine_transform_test
  1724. sir_ode, an Octave code which sets up and solves the ordinary differential equations (ODE) which simulate the spread of a disease using the Susceptible/Infected/Recovered (SIR) model.
  1725. sir_ode_test
  1726. sir_simulation, an Octave code which simulates the spread of a disease through a hospital room of M by N beds, using the Susceptible/Infected/Recovered (SIR) model.
  1727. sir_simulation_test
  1728. sling_ode, an Octave code which sets up and solves a system of ordinary differential equations (ODE) for which the exact circular solution can only be approximated for a short interval before it decays to zero.
  1729. sling_ode_test
  1730. snakes_and_ladders, an Octave code which provides tools for studying the game of Snakes and Ladders.
  1731. snakes_and_ladders_simulation, an Octave code which simulates a one-player game of Snakes and Ladders, to produce histograms of the count, PDF and CDF estimates for the length of a one-player game.
  1732. snakes_and_ladders_simulation_test
  1733. snakes_matrix, an Octave code which returns the transition matrix for the game of Snakes and Ladders.
  1734. snakes_matrix_test
  1735. snakes_probability, an Octave code which computes the game length probabilities for the game of Snakes and Ladders, by Desmond Higham and Nicholas Higham.
  1736. snakes_probability_test
  1737. solve, an Octave code which uses Gauss elimination to solve a linear system A*x=b.
  1738. solve_test
  1739. sor, an Octave code which uses the successive over-relaxation (SOR) iteration to solve a linear system of equations.
  1740. sor_test
  1741. sort_test, an Octave code which calls the sort() function to sort objects of several types.
  1742. '
  1743. sort_rc, an Octave code which sorts a list of any kind of objects, using reverse communication (RC).
  1744. sort_rc_test
  1745. sparse_test, an Octave code which tests the sparse() function for creating sparse matrices and carrying out linear algebraic functions on them;
  1746. sparse_display, an Octave code which reads information defining a matrix of numbers and displays the sparsity pattern or location of the nonzero elements using gnuplot(). This operation is already available in the built-in matplotlib spy() function.
  1747. sparse_display_test
  1748. sparse_grid_cc, an Octave code which creates sparse grids based on Clenshaw-Curtis (CC) quadrature rules.
  1749. sparse_grid_cc_test
  1750. sparse_grid_gl, an Octave code which creates sparse grids based on Gauss-Legendre (GL) rules.
  1751. sparse_grid_gl_test
  1752. sparse_grid_hermite, an Octave code which creates sparse grids based on Gauss-Hermite rules.
  1753. sparse_grid_hermite_test
  1754. sparse_grid_hw, an Octave code which creates sparse grids based on Gauss-Legendre, Gauss-Hermite, Gauss-Patterson, or a nested variation of Gauss-Hermite rules, by Florian Heiss and Viktor Winschel.
  1755. sparse_grid_hw_test
  1756. sparse_grid_laguerre, an Octave code which creates sparse grids based on Gauss-Laguerre rules.
  1757. sparse_grid_laguerre_test
  1758. sparse_grid_mixed, an Octave code which creates a sparse grid dataset based on a mixed set of 1D factor rules.
  1759. sparse_grid_mixed_test
  1760. sparse_grid_total_poly, an Octave code which investigates the total polynomial approximation using sparse grids.
  1761. sparse_grid_total_poly_test
  1762. sparse_interp_nd, an Octave code which defines a sparse interpolant to a function f(x) of a M dimensional argument.
  1763. sparse_interp_nd_test
  1764. spd_test, an Octave code which performs a few tests on a real matrix to determine whether it is symmetric positive definite (SPD).
  1765. sphere_cubed_grid, an Octave code which uses the projection of a cube to create grids of points, lines, and quadrilaterals on the surface of the unit sphere in 3D.
  1766. sphere_cubed_grid_test
  1767. sphere_cvt, an Octave code which carries out the Centroidal Voronoi Tessellation (CVT) iteration on the surface of the unit sphere in 3D.
  1768. sphere_cvt_test
  1769. sphere_delaunay, an Octave code which computes the Delaunay triangulation of points on the surface of the unit sphere in 3D.
  1770. sphere_delaunay_test
  1771. sphere_distance, an Octave code which computes the expected value of the distance between a pair of points randomly selected on the surface of the unit sphere in 3D.
  1772. sphere_distance_test
  1773. sphere_exactness, an Octave code which tests the polynomial exactness of a quadrature rule on the surface of the unit sphere in 3D.
  1774. sphere_exactness_test
  1775. sphere_fibonacci_grid, an Octave code which uses a Fibonacci spiral to create a grid of points on the surface of the unit sphere in 3D.
  1776. sphere_fibonacci_grid_test
  1777. sphere_grid, an Octave code which provides a number of ways of generating grids of points, or of points and lines, or of points and lines and faces, on the surface of the unit sphere in 3D.
  1778. sphere_grid_test
  1779. sphere_integrals, an Octave code which returns the exact value of the integral of any monomial over the surface of the unit sphere in 3D.
  1780. sphere_integrals_test
  1781. sphere_lebedev_rule, an Octave code which computes Lebedev quadrature rules on the surface of the unit sphere in 3D.
  1782. sphere_lebedev_rule_test
  1783. sphere_lebedev_rule_display, an Octave code which reads a file defining a Lebedev quadrature rule on the surface of the unit sphere in 3D and displays the point locations.
  1784. sphere_lebedev_rule_display_test
  1785. sphere_llq_grid, an Octave code which uses longitudes and latitudes to create grids of points, lines, and quadrilaterals on the surface of the unit sphere in 3D.
  1786. sphere_llq_grid_test
  1787. sphere_llt_grid, an Octave code which uses longitudes and latitudes to create grids of points, lines, and triangles on the surface of the unit sphere in 3D.
  1788. sphere_llt_grid_test
  1789. sphere_monte_carlo, an Octave code which applies a Monte Carlo method to estimate the integral of a function on the surface of the unit sphere in 3D.
  1790. sphere_monte_carlo_test
  1791. sphere_positive_distance, an Octave code which computes the expected value of the distance between a pair of points randomly selected on the surface of the unit positive sphere in 3D.
  1792. sphere_positive_distance_test
  1793. sphere_quad, an Octave code which uses triangulation to approximate an integral on the surface of the unit sphere in 3D.
  1794. sphere_quad_test
  1795. sphere_stereograph, an Octave code which computes the stereographic mapping between points on the surface of the unit sphere in 3D and points on the plane Z = 1; a generalized mapping is also available.
  1796. sphere_stereograph_test
  1797. sphere_stereograph_display, an Octave code which computes and displays the results of several stereographic projections between points on the surface of the unit sphere in 3D and a plane.
  1798. sphere_stereograph_display_test
  1799. sphere_triangle_monte_carlo, an Octave code which applies a Monte Carlo method to estimate the integral of a function over a spherical triangle on the surface of the unit sphere in 3D;
  1800. sphere_triangle_monte_carlo_test
  1801. sphere_triangle_quad, an Octave code which uses quadrature to estimate the integral of a function over a spherical triangle on the surface of the unit sphere in 3D.
  1802. sphere_triangle_quad_test
  1803. sphere_voronoi, an Octave code which computes the Voronoi diagram of points on the surface of the unit sphere in 3D.
  1804. sphere_voronoi_test
  1805. spiral_data, an Octave code which computes a velocity vector field that satisfies the continuity equation in 2D, writing the data to a file that can be plotted or analyzed.
  1806. spiral_data_test
  1807. spline, an Octave code which interpolates and approximates via splines;
  1808. spline_test
  1809. spquad, an Octave code which computes the points and weights of a sparse grid quadrature rule for an M-dimensional integral, based on the Clenshaw-Curtis quadrature rule, by Greg von Winckel.
  1810. spquad_test
  1811. spring_ode, an Octave code which sets up and solves a system of ordinary differential equations (ODE) for the motion of a spring with mass m, damping b, and stiffness k.
  1812. spring_ode_test
  1813. spring_double_ode, an Octave code which sets up and solves a system of ordinary differential equations (ODE) for a system in which a mass is connected by a spring to a mass connected by a spring to a fixed support.
  1814. spring_double_ode_test
  1815. spring_sweep_ode, an Octave code which computes a grid of solutions to a parameterized system of ordinary differential equations (ODE) that represent the motion of a spring with mass m, damping b, and stiffness k.
  1816. spring_sweep_ode_test
  1817. square_arbq_rule, an Octave code which returns quadrature rules, with exactness up to total degree 20, over the interior of the symmetric square in 2D, by Hong Xiao and Zydrunas Gimbutas.
  1818. square_arbq_rule_test
  1819. square_distance, an Octave code which computes the expected value of the distance between a pair of points randomly selected from the interior of the unit square in 2D.
  1820. square_distance_test
  1821. square_exactness, an Octave code which investigates the polynomial exactness of quadrature rules for f(x,y) over the interior of a rectangle in 2D.
  1822. square_exactness_test
  1823. square_felippa_rule, an Octave code which returns a Felippa quadrature rules for approximating integrals over the interior of a square in 2D.
  1824. square_felippa_rule_test
  1825. square_grid, an Octave code which computes a grid of points over the interior of a square in 2D.
  1826. square_grid_test
  1827. square_hex_grid, an Octave code which computes a hexagonal grid of points over the interior of a square in 2D.
  1828. square_hex_grid_test
  1829. square_integrals, an Octave code which returns the exact value of the integral of any monomial over the interior of the unit square or symmetric unit square in 2D.
  1830. square_integrals_test
  1831. square_minimal_rule, an Octave code which returns "almost minimal" quadrature rules, with exactness up to total degree 55, over the interior of the symmetric square in 2D, by Mattia Festa and Alvise Sommariva.
  1832. square_minimal_rule_test
  1833. square_monte_carlo, an Octave code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit square in 2D.
  1834. square_monte_carlo_test
  1835. square_surface_distance, an Octave code which estimates the expected value of the distance between a pair of points randomly selected on the surface of the unit square.
  1836. square_surface_distance_test
  1837. square_symq_rule, an Octave code which returns symmetric quadrature rules, with exactness up to total degree 20, over the interior of the symmetric square in 2D, by Hong Xiao and Zydrunas Gimbutas.
  1838. square_symq_rule_test
  1839. squircle_ode, an Octave code which sets up and solves a system of ordinary differential equations (ODE) for a pair of functions that generalize the sine and cosine, and whose phase portrait is a squircle, a sort of squared circle.
  1840. squircle_ode_test
  1841. st_io, an Octave code which reads and writes sparse linear systems stored in the Sparse Triplet (ST) format.
  1842. st_io_test
  1843. st_to_ccs, an Octave code which converts sparse matrix data from Sparse Triplet (ST) format to Compressed Column Storage (CCS) format;
  1844. st_to_ccs_test
  1845. st_to_hb, an Octave code which converts sparse matrix data from Sparse Triplet (ST) format to Harwell Boeing (HB) format;
  1846. st_to_hb_test
  1847. st_to_mm, an Octave code which converts sparse matrix data from Sparse Triplet (ST) format to Matrix Market (MM) format;
  1848. st_to_mm_test
  1849. st_to_msm, an Octave code which reads a Sparse Triplet (ST) file and creates a corresponding MATLAB Sparse Matrix (MSM).
  1850. st_to_msm_test
  1851. stetter_ode, an Octave code which sets up and solves an ordinary differential equation (ODE) for which a specific time step sequence causes the implicit trapezoidal method to be unstable, while the implicit midpoint method will be stable. Note that the right hand side function f(t,y) is periodic, discontinuous, and piecewise linear.
  1852. stetter_ode_test
  1853. stiff_ode, an Octave code which sets up and solves an ordinary differential equation (ODE) which is an example of a stiff ODE.
  1854. stiff_ode_test
  1855. stla_display, an Octave code which displays an ASCII stereolithography (STL) 3D graphics file;
  1856. stla_display_test
  1857. stla_io, an Octave code which reads and writes an ASCII stereolithography (STL) 3D graphics file;
  1858. stla_io_test
  1859. stla_to_tri_surface, an Octave code which reads an ASCII stereolithography (STL) 3D graphics file and extracts the surface mesh data as a TRI_SURFACE dataset.
  1860. stla_to_tri_surface_test
  1861. stla_to_tri_surface_fast, an Octave code which is a faster version of stla_to_tri_surface().
  1862. stla_to_tri_surface_fast_test
  1863. stochastic_diffusion, an Octave code which implements several versions of a stochastic diffusivity coefficient.
  1864. stochastic_diffusion_test
  1865. stochastic_rk, an Octave code which applies a Runge Kutta (RK) scheme to a stochastic ordinary differential equation (SDE).
  1866. stochastic_rk_test
  1867. stokes_2d_exact, an Octave code which evaluates exact solutions to the incompressible steady Stokes equations over the unit square in 2D.
  1868. stokes_2d_exact_test
  1869. string_pde, an Octave code which sets up and solves the partial differential equations (PDE) describing a vibrating string, creating files that can be displayed by gnuplot().
  1870. string_pde_test
  1871. subset, an Octave code which enumerates, generates, randomizes, ranks and unranks combinatorial objects including combinations, compositions, Gray codes, index sets, partitions, permutations, polynomials, subsets, and Young tables. Backtracking routines are included to solve some combinatorial problems.
  1872. subset_test
  1873. subset_distance, an Octave code which estimates the expected value of the Hamming distance between a pair of randomly selected subsets of an M set.
  1874. subset_distance_test
  1875. subset_sum, an Octave code which seeks solutions of the subset sum problem, in which it is desired to find a subset of integers which has a given sum.
  1876. subset_sum_test
  1877. subset_sum_backtrack, an Octave code which uses backtracking to find solutions of the subset sum problem, in which it is desired to find a subset of integers which has a given sum.
  1878. subset_sum_backtrack_test
  1879. subset_sum_brute, an Octave code which seeks solutions of the subset sum problem, using a brute force approach.
  1880. subset_sum_brute_test
  1881. svd_test, an Octave code which demonstrates the Singular Value Decomposition (SVD) for a simple example.
  1882. svd_basis, an Octave code which applies the singular value decomposition (SVD) to a collection of data vectors, extracting dominant modes;
  1883. svd_basis_test
  1884. svd_circle, an Octave code which analyzes a linear map of the unit circle caused by an arbitrary 2x2 matrix A, using the singular value decomposition (SVD).
  1885. svd_circle_test
  1886. svd_faces, an Octave code which applies singular value decomposition (SVD) analysis to a set of images.
  1887. svd_faces_test
  1888. svd_fingerprint, an Octave code which reads a file containing a fingerprint image and uses the singular value decomposition (SVD) to compute and display a series of low rank approximations to the image.
  1889. svd_fingerprint_test
  1890. svd_gray, an Octave code which reads a gray scale image, computes the Singular Value Decomposition (SVD), and constructs a series of low rank approximations to the image.
  1891. svd_gray_test
  1892. svd_lls, an Octave code which uses the singular value decomposition (SVD) to construct and plot the best affine and linear relationships in the sense of least square, between two vectors of data.
  1893. svd_lls_test
  1894. svd_powers, an Octave code which applies singular value decomposition (SVD) analysis to a set of powers x(i)^(j-1).
  1895. svd_powers_test
  1896. svd_snowfall, an Octave code which reads a file containing historical snowfall data and analyzes the data with the Singular Value Decomposition (SVD).
  1897. svd_snowfall_test
  1898. svd_sphere, an Octave code which analyzes a linear map of the unit sphere caused by an arbitrary 3x3 matrix A, using the singular value decomposition (SVD).
  1899. svd_sphere_test
  1900. svd_truncated_test, an Octave code which calls the "economy" version of the Singular Value Decomposition (SVD) of an M by N rectangular matrix, in cases where M is less than N or N is less than M.
  1901. sympy_test, an Octave code which tests sympy(), the symbolic mathematics package.
  1902. table_io, an Octave code which reads and writes a simple table file;
  1903. table_io_test
  1904. task_division, an Octave code which implements a simple procedure for smoothly dividing T tasks among P processors; such a method can be useful in MPI and other parallel environments, particularly when T is not an exact multiple of P, and when the processors can be indexed starting from 0 or from 1.
  1905. task_division_test
  1906. tennis_matrix, an Octave code which computes the transition matrix for a game of tennis, which has 17 distinct states.
  1907. tennis_matrix_test
  1908. tensor_grid_display, an Octave code which displays the grid points of a tensor product rule used for interpolation or quadrature, in 1D, 2D or 3D.
  1909. tensor_grid_display_test
  1910. test_approx, an Octave code which implements test problems for approximation, provided as a set of (x,y) data.
  1911. test_approx_test
  1912. test_con, an Octave code which implements test problems for numerical continuation.
  1913. test_con_test
  1914. test_eigen, an Octave code which implements test matrices for eigenvalue analysis.
  1915. test_eigen_test
  1916. test_int, an Octave code which implements test problems for approximate integration (quadrature) in one dimension.
  1917. test_int_test
  1918. test_int_2d, an Octave code which implements test problems for approximate integration (quadrature) in two dimensions.
  1919. test_int_2d_test
  1920. test_interp, an Octave code which defines test problems for interpolation, provided as a set of (x,y(x)) data.
  1921. test_interp_test
  1922. test_interp_1d, an Octave code which defines test problems for interpolation of data y(x), which depends on a 1D argument.
  1923. test_interp_1d_test
  1924. test_interp_2d, an Octave code which defines test problems for interpolation of data z(x,y), which depends on a 2D argument.
  1925. test_interp_2d_test
  1926. test_interp_fun, an Octave code which defines test problems for interpolation which are available in functional form.
  1927. test_interp_fun_test
  1928. test_interp_nd, an Octave code which defines test problems for interpolation of data z(x), depending on an M dimensional argument.
  1929. test_interp_nd_test
  1930. test_lls, an Octave code which implements linear least squares (LLS) test problems of the form A*x=b.
  1931. test_lls_test
  1932. test_matrix, an Octave code which defines test matrices for which the condition number, determinant, eigenvalues, eigenvectors, inverse, null vectors, P*L*U factorization or linear system solution are known. Examples include the Fibonacci, Hilbert, Redheffer, Vandermonde, Wathen and Wilkinson matrices.
  1933. test_matrix_test
  1934. test_matrix_exponential, an Octave code which defines a set of test cases for computing the matrix exponential.
  1935. test_matrix_exponential_test
  1936. test_min, an Octave code which implements test problems for minimization of a scalar function of a scalar variable.
  1937. test_min_test
  1938. test_nearest, an Octave code which tests the time complexity of various procedures for solving the nearest neighbor problem.
  1939. test_nearest_test
  1940. test_nint, an Octave code which defines test functions for M-dimensional quadrature routines.
  1941. test_nint_test
  1942. test_nonlin, an Octave code which implements test problems for the solution of systems of nonlinear equations.
  1943. test_nonlin_test
  1944. test_opt, an Octave code which implements test problems for optimization of a scalar function of several variables.
  1945. test_opt_test
  1946. test_opt_con, an Octave code which defines test problems for the minimization of a scalar function of several variables, with the search constrained to lie within a specified hyper-rectangle.
  1947. test_opt_con_test
  1948. test_optimization, an Octave code which implements test problems for optimization of a scalar function of several variables, as described by Molga and Smutnicki.
  1949. test_optimization_test
  1950. test_partial_digest, an Octave code which generates example cases of the partial digest problem.
  1951. test_partial_digest_test
  1952. test_triangulation, an Octave code which defines test problems for triangulation;
  1953. test_triangulation_test
  1954. test_values, an Octave code which supplies test values of various mathematical functions, including Abramowitz, AGM, Airy, Bell, Bernoulli, Bessel, Beta, Binomial, Bivariate Normal, Catalan, Cauchy, Chebyshev, Chi Square, Clausen, Clebsch Gordan, Collatz, Cosine integral, Dawson, Debye, Dedekind, dilogarithm, Exponential integral, Elliptic, Error, Euler, Exponential integral, F probability, Fresnel, Frobenius, Gamma, Gegenbauer, Goodwin, Gudermannian, Harmonic, Hermite, Hypergeometric 1F1, Hypergeometric 2F1, inverse trigonometic, Jacobi, Julian Ephemeris Date, Kelvin, Laguerre, Laplace, Legendre, Lerch, Lobachevsky, Lobatto, Logarithmic integral, Log normal, McNugget numbers, Mertens, Mittag-Leffler, Moebius, Multinomial, Negative binomial, Nine J, Normal, Omega, Owen, Partition, Phi, Pi, Poisson, Polylogarithm, Polyomino, Prime, Psi, Rayleigh, Hyperbolic Sine integral, Sigma, Sine Power integral, Sine integral, Six J, Sphere area, Sphere volume, Spherical harmonic, Stirling, Stromgen, Struve, Student, Subfactorial, Student probability, Three J, Transport, Trigamma, Truncated normal, van der Corput, von Mises, Weibull, Wright omega, Zeta.
  1955. test_values_test
  1956. test_zero, an Octave code which defines some functions f(x) suitable for testing software that solves a nonlinear equation f(x)=0;
  1957. test_zero_test
  1958. tester, a BASH script which runs the Octave tests.
  1959. tet_mesh, an Octave code which works with tetrahedral meshes in 3D;
  1960. tet_mesh_test
  1961. tet_mesh_boundary, an Octave code which reads information defining a tetrahedral mesh of points in 3D, and determines the triangular faces that form the boundary of the mesh; it writes out files containing the nodes and elements defining this TRI_SURFACE data.
  1962. tet_mesh_boundary_test
  1963. tet_mesh_display, an Octave code which reads data defining a tetrahedral mesh, and displays a wireframe image of the nodes and edges;
  1964. tet_mesh_display_test
  1965. tet_mesh_l2q, an Octave code which reads information about a 4-node linear mesh of tetrahedrons and creates data defining a corresponding 10-node quadratic mesh of tetrahedrons;
  1966. tet_mesh_l2q_test
  1967. tet_mesh_q2l, an Octave code which reads information about a 10-node quadratic mesh of tetrahedrons and creates data defining a corresponding 4-node linear mesh of tetrahedrons;
  1968. tet_mesh_q2l_test
  1969. tet_mesh_quad, an Octave code which estimates the integral of a function over a region defined by a tetrahedral mesh.
  1970. tet_mesh_quad_test
  1971. tet_mesh_quality, an Octave code which computes various quality measures for a tetrahedral mesh of a set of nodes in 3D;
  1972. tet_mesh_quality_test
  1973. tet_mesh_rcm, an Octave code which computes the Reverse Cuthill McKee (RCM) reordering for the nodes of a mesh of tetrahedrons, using 4 or 10 node elements.
  1974. tet_mesh_rcm_test
  1975. tet_mesh_refine, an Octave code which refines a mesh of tetrahedrons;
  1976. tet_mesh_refine_test
  1977. tet_mesh_tet_neighbors, an Octave code which reads information about a tetrahedral mesh and lists the tetrahedrons adjacent to a given tetrahedron;
  1978. tet_mesh_tet_neighbors_test
  1979. tet_mesh_to_gmsh, an Octave code which write a gmsh() file describing a tetrahedral mesh;
  1980. tet_mesh_to_gmsh_test
  1981. tet_mesh_to_xml, an Octave code which write an XML file describing a tetrahedral mesh;
  1982. tet_mesh_to_xml_test
  1983. tet_mesh_volumes, an Octave code which computes the volume of each tetrahedron in a mesh of tetrahedrons;
  1984. tet_mesh_volumes_test
  1985. tetrahedron, an Octave code which carries out geometric calculations involving a general tetrahedron, including solid and facial angles, face areas, point containment, distances to a point, circumsphere and insphere, measures of shape quality, centroid, barycentric coordinates, edges and edge lengths, random sampling, and volumes.
  1986. tetrahedron_test
  1987. tetrahedron_arbq_rule, an Octave code which returns quadrature rules, with exactness up to total degree 15, over the interior of a tetrahedron in 3D, by Hong Xiao and Zydrunas Gimbutas.
  1988. tetrahedron_arbq_rule_test
  1989. tetrahedron_exactness, an Octave code which tests the polynomial exactness of a quadrature rule over the interior of a tetrahedron in 3D.
  1990. tetrahedron_exactness_test
  1991. tetrahedron_felippa_rule, an Octave code which returns a Felippa quadrature rules for approximating integrals over the interior of a tetrahedron in 3D.
  1992. tetrahedron_felippa_rule_test
  1993. tetrahedron_grid, an Octave code which computes a grid of points over the interior of a tetrahedron in 3D.
  1994. tetrahedron_grid_test
  1995. tetrahedron_integrals, an Octave code which returns the exact value of the integral of any monomial over the interior of the unit tetrahedron in 3D.
  1996. tetrahedron_integrals_test
  1997. tetrahedron_jaskowiec_rule, an Octave code which returns quadrature rules, with exactness up to total degree 20, over the interior of a tetrahedron in 3D, by Jan Jaskowiec, Natarajan Sukumar.
  1998. tetrahedron_jaskowiec_rule_test
  1999. tetrahedron_keast_rule, an Octave code which defines a Keast quadrature rule, of degree of exactness 0 through 8, over the interior of the tetrahedron in 3D.
  2000. tetrahedron_keast_rule_test
  2001. tetrahedron_monte_carlo, an Octave code which uses the Monte Carlo method to estimate an integral over the interior of a general tetrahedron in 3D.
  2002. tetrahedron_monte_carlo_test
  2003. tetrahedron_ncc_rule, an Octave code which defines Newton-Cotes closed (NCC) quadrature rules over the interior of a tetrahedron in 3D.
  2004. tetrahedron_ncc_rule_test
  2005. tetrahedron_nco_rule, an Octave code which defines Newton-Cotes open (NCO) quadrature rules over the interior of a tetrahedron in 3D.
  2006. tetrahedron_nco_rule_test
  2007. tetrahedron_slice_display, an Octave code which determines the intersection between a tetrahedron and a plane and displays the result.
  2008. tetrahedron_slice_display_test
  2009. tetrahedron_witherden_rule, an Octave code which returns a symmetric Witherden quadrature rule for the tetrahedron, with exactness up to total degree 10.
  2010. tetrahedron_witherden_rule_test
  2011. tetrahedron01_monte_carlo, an Octave code which uses the Monte Carlo method to estimate an integral over the interior of the unit tetrahedron in 3D.
  2012. tetrahedron01_monte_carlo_test
  2013. theta_method, an Octave code which solves one or more ordinary differential equations (ODE) using the theta method.
  2014. theta_method_test
  2015. three_body_ode, an Octave code which sets up and solves ordinary differential equations (ODE) that simulate the behavior of three planets, constrained to lie in a plane, and moving under the influence of gravity, by Walter Gander and Jiri Hrebicek.
  2016. three_body_ode_test
  2017. tictoc_test, an Octave code which calls tic() and toc(), which compute elapsed time.
  2018. timer_test, an Octave code which demonstrates and compares several ways of timing code execution.
  2019. timestamp, an Octave code which prints the current YMDHMS date as a timestamp;
  2020. timestamp_test
  2021. toeplitz_cholesky, an Octave code which computes the Cholesky factorization of a symmetric positive definite (SPD) Toeplitz matrix.
  2022. toeplitz_cholesky_test
  2023. toeplitz_inverse, an Octave code which computes the inverse of a Toeplitz matrix.
  2024. toeplitz_inverse_test
  2025. toms097, an Octave code which computes the distance between all pairs of nodes in a directed graph with weighted edges, using the Floyd algorithm. This is a version of ACM TOMS algorithm 97.
  2026. toms097_test
  2027. toms112, an Octave code which determines whether a point is contained in a polygon, by Moshe Shimrat. This is a version of ACM TOMS algorithm 112.
  2028. toms112_test
  2029. toms178, an Octave code which optimizes a scalar functional of multiple variables using the Hooke-Jeeves method, by Arthur Kaupe. This is a version of ACM TOMS algorithm 178.
  2030. toms178_test
  2031. toms179, an Octave code which evaluates the modified Beta function, by Oliver Ludwig. This is a version of ACM TOMS algorithm 179.
  2032. toms179_test
  2033. toms243, an Octave code which evaluates the logarithm of a complex value, by David Collens. This is a version of ACM TOMS algorithm 243.
  2034. toms243_test
  2035. toms291, an Octave code which evaluates the logarithm of the Gamma function. This is a version of ACM TOMS algorithm 291.
  2036. toms291_test
  2037. toms443, an Octave code which evaluates the Lambert W function, by Fritsch, Shafer and Crowley. This is a version of ACM TOMS algorithm 443.
  2038. toms443_test
  2039. toms446, an Octave code which manipulates Chebyshev series for interpolation and approximation; this is a version of ACM TOMS algorithm 446, by Roger Broucke.
  2040. toms446_test
  2041. toms462, an Octave code which evaluates the upper right tail of the bivariate normal Probability Density Function (PDF); that is, the probability that normal variables X and Y with correlation R will satisfy H <= X and K <= Y; this is a version of ACM TOMS algorithm 462.
  2042. toms462_test
  2043. toms515, an Octave code which selects subsets of size K from a set of size N. This is a version of ACM TOMS Algorithm 515, by Bill Buckles, Matthew Lybanon.
  2044. toms515_test
  2045. toms577, an Octave code which evaluates the Carlson elliptic integral functions RC, RD, RF and RJ. This is a version of ACM TOMS algorithm 577;
  2046. toms577_test
  2047. toms655, an Octave code which computes the weights for interpolatory quadrature rules; this is commonly called IQPACK, by Sylvan Elhay and Jaroslav Kautsky. This is a version of ACM TOMS algorithm 655.
  2048. toms655_test
  2049. toms743, an Octave code which evaluates the Lambert W function. This is a version of ACM TOMS algorithm 743, by Barry, Barry and Culligan-Hensley.
  2050. toms743_test
  2051. toms847, an Octave code which carries out piecewise linear (PWL) multidimensional hierarchical sparse grid interpolation; this is commonly called spinterp() (version 2.1); this is a version of ACM TOMS Algorithm 847, by Andreas Klimke;
  2052. toms847_test
  2053. toms866, an Octave code which is version 2.2 of the Incompressible Flow Iterative Solution Software (IFISS), for fluid flow governed by the Navier Stokes equations (NSE), by Howard Elman, Alison Ramage, David Silvester; this is a version of ACM TOMS algorithm 866.
  2054. toms886, an Octave code which defines the Padua points for interpolation in a 2D region, including the rectangle, triangle, and ellipse, by Marco Caliari, Stefano de Marchi, Marco Vianello. This is a version of ACM TOMS algorithm 886.
  2055. toms886_test
  2056. toms923, an Octave code which evaluates the Pfaffian for a dense or banded skew symmetric matrix, by Michael Wimmer.
  2057. toms923_test
  2058. tough_ode, an Octave code which sets up and solves a system of four ordinary differential equations (ODE) which is extremely difficult to solve accurately.
  2059. tough_ode_test
  2060. traffic_simulation, an Octave code which simulates the cars waiting to get through a traffic light.
  2061. traffic_simulation_test
  2062. trapezoidal, an Octave code which solves one or more ordinary differential equations (ODE) using the (implicit) trapezoidal method, and fsolve() for the implicit system.
  2063. trapezoidal_test
  2064. trapezoidal_explicit, an Octave code which solves one or more ordinary differential equations (ODE) using the (explicit) trapezoidal method.
  2065. trapezoidal_explicit_test
  2066. trapezoidal_fixed, an Octave code which solves one or more ordinary differential equations (ODE) using the (implicit) trapezoidal method, and a fixed point method for the implicit system.
  2067. trapezoidal_fixed_test
  2068. tri_surface_display, an Octave code which displays a TRI_SURFACE object representing a triangulated surface;
  2069. tri_surface_display_test
  2070. tri_surface_to_obj, an Octave code which reads a TRI_SURFACE dataset and extracts the surface mesh data as an OBJ file.
  2071. tri_surface_to_obj_test
  2072. tri_surface_to_stla, an Octave code which reads a TRI_SURFACE dataset and extracts the surface mesh data as an ASCII stereolithography (STL) file.
  2073. tri_surface_to_stla_test
  2074. triangle, an Octave code which computes properties of a triangle, including angles, area, centroid, circumcircle, edge lengths, incircle, orientation, orthocenter, quality, Cartesian to barycentric coordinates, barycentric coordinates to Cartesian. A point is treated as a (1,2) array, a list of points as an (n,2) array, and a triangle as a (3,2) array.
  2075. triangle_test
  2076. triangle_analyze, an Octave code which reads a triangle defined in a file and computes angles, area, centroid, circumcircle, edge lengths, incircle, orientation, orthocenter, and quality.
  2077. triangle_analyze_test
  2078. triangle_display, an Octave code which displays the nodes and elements of a triangulation for which the data has been stored in NODE and ELE files by Jonathan Shewchuk's triangle() program.
  2079. triangle_display_test
  2080. triangle_distance, an Octave code which computes the expected value of the distance between a pair of points randomly selected from the interior of a triangle in 2D.
  2081. triangle_distance_test
  2082. triangle_dunavant_rule, an Octave code which returns a Dunavant quadrature rule over the interior of a triangle in 2D.
  2083. triangle_dunavant_rule_test
  2084. triangle_exactness, an Octave code which tests the polynomial exactness of a quadrature rule over the interior of a triangle in 2D.
  2085. triangle_exactness_test
  2086. triangle_fekete_rule, an Octave code which returns a Fekete rule for interpolation or quadrature over the interior of a triangle in 2D.
  2087. triangle_fekete_rule_test
  2088. triangle_felippa_rule, an Octave code which returns a Felippa quadrature rule for approximating integrals over the interior of a triangle in 2D.
  2089. triangle_felippa_rule_test
  2090. triangle_grid, an Octave code which computes a grid of points over the interior of a triangle in 2D.
  2091. triangle_grid_test
  2092. triangle_histogram, an Octave code which computes histograms of data over the interior of a unit triangle in 2D.
  2093. triangle_histogram_test
  2094. triangle_integrals, an Octave code which returns the exact value of the integral of any polynomial over the interior of an arbitrary triangle in 2D.
  2095. triangle_integrals_test
  2096. triangle_integrands, an Octave code which defines integrands for testing quadrature rules over a triangle.
  2097. triangle_integrands_test
  2098. triangle_interpolate, an Octave code which shows how vertex data can be interpolated at any point in the interior of a triangle.
  2099. triangle_interpolate_test
  2100. triangle_io, an Octave code which reads or writes files created by Jonathan Shewchuk's triangle() program.
  2101. triangle_io_test
  2102. triangle_lyness_rule, an Octave code which returns Lyness-Jespersen quadrature rules over the interior of a triangle in 2D;
  2103. triangle_lyness_rule_test
  2104. triangle_monte_carlo, an Octave code which uses the Monte Carlo method to estimate an integral over the interior of a general triangle in 2D.
  2105. triangle_monte_carlo_test
  2106. triangle_ncc_rule, an Octave code which defines Newton-Cotes Closed (NCC) quadrature rules over the interior of a triangle in 2D.
  2107. triangle_ncc_rule_test
  2108. triangle_nco_rule, an Octave code which defines Newton-Cotes Open (NCO) quadrature rules over the interior of a triangle in 2D.
  2109. triangle_nco_rule_test
  2110. triangle_quadrature_symmetry, an Octave code which determines the symmetries of a quadrature rule for a triangle.
  2111. triangle_quadrature_symmetry_test
  2112. triangle_refine, an Octave code which divides a triangle into c^2 copies of itself, and implements a simple centroid-based quadrature scheme.
  2113. triangle_refine_test
  2114. triangle_svg, an Octave code which uses Scalable Vector graphics (SVG) to plot a triangle and any number of points, to illustrate quadrature rules and sampling techniques.
  2115. triangle_svg_test
  2116. triangle_symq_rule, an Octave code which returns efficient symmetric quadrature rules, with exactness up to total degree 50, over the interior of a triangle in 2D, by Hong Xiao and Zydrunas Gimbutas.
  2117. triangle_symq_rule_test
  2118. triangle_symq_to_ref, an Octave code which creates quadrature rules defined on the half-unit square from symmetric quadrature rules defined on an equilateral triangle, defined by triangle_symq_rule(), by Hong Xiao and Zydrunas Gimbutas.
  2119. triangle_symq_to_ref_test
  2120. triangle_to_fem, an Octave code which reads the NODE and ELE files created by Jonathan Shewchuk's triangle() program to describe a triangular mesh, and writes a corresponding pair of node and element files in the 2D FEM format.
  2121. triangle_to_fem_test
  2122. triangle_to_medit, an Octave code which reads the NODE and ELE files created by Jonathan Shewchuk's triangle() program to describe a triangular mesh, and writes a corresponding medit() MESH file.
  2123. triangle_to_medit_test
  2124. triangle_to_xml, an Octave code which reads the NODE and ELE files created by Jonathan Shewchuk's triangle() program to describe a triangular mesh in 2D, and writes a corresponding XML mesh file for use by dolfin() or fenics().
  2125. triangle_to_xml_test
  2126. triangle_twb_rule, an Octave code which generates the points and weights of quadrature rules over the interior of a triangle in 2D, determined by Taylor, Wingate, and Bos.
  2127. triangle_twb_rule_test
  2128. triangle_wandzura_rule, an Octave code which returns a Wandzura quadrature rule of exactness 5, 10, 15, 20, 25 and 30 over the interior of the triangle in 2D.
  2129. triangle_wandzura_rule_test
  2130. triangle_witherden_rule, an Octave code which returns a symmetric Witherden quadrature rule for the triangle, with exactness up to total degree 20.
  2131. triangle_witherden_rule_test
  2132. triangle01_integrals, an Octave code which returns the integral of any monomial over the interior of the unit triangle in 2D.
  2133. triangle01_integrals_test
  2134. triangle01_monte_carlo, an Octave code which uses the Monte Carlo method to estimate an integral over the interior of the unit triangle in 2D.
  2135. triangle01_monte_carlo_test-
  2136. triangulate, an Octave code which triangulates a polygonal region, based on a C program by Joseph ORourke;
  2137. triangulate_test
  2138. triangulate_rectangle, an Octave code which sets up a grid of triangles in a rectangular region.
  2139. triangulate_rectangle_test
  2140. triangulation, an Octave code which computes the triangulation of a set of points in the plane, and performs various operations using a triangulation, including searching a Delaunay triangulation to find which triangle contains a given point.
  2141. triangulation_test
  2142. triangulation_boundary, an Octave code which starts with a triangulation of a simple shape, and determines the triangle edges that form the boundary, and a sequence of nodes that trace the boundary.
  2143. triangulation_boundary_test
  2144. triangulation_boundary_edges, an Octave code which reads data defining a triangulation, determines which edges lie on the boundary, organizes them into connected components, and writes this information to a file.
  2145. triangulation_boundary_edges_test
  2146. triangulation_boundary_nodes, an Octave code which reads data defining a triangulation, determines which nodes lie on the boundary, and writes their coordinates to a file;
  2147. triangulation_boundary_nodes_test
  2148. triangulation_delaunay_discrepancy, an Octave code which measures the amount by which a triangulation fails the local Delaunay test;
  2149. triangulation_delaunay_discrepancy_test
  2150. triangulation_display, an Octave code which displays the nodes and elements of a triangulation;
  2151. triangulation_display_test
  2152. triangulation_node_to_element, an Octave code which reads files describing a set of nodes, their triangulation, and the value of one or more quantities at each node, and outputs a file that averages the quantities for each element. This operation in effect creates an order1 finite element model of the data.
  2153. triangulation_node_to_element_test
  2154. triangulation_order1_display, an Octave code which plots piecewise constant (PWC) data associated with a triangulation;
  2155. triangulation_order1_display_test
  2156. triangulation_order3_contour, an Octave code which plots color contours of a piecewise linear (PWL) scalar quantity evaluated at the nodes of a 3-node triangle triangulation.
  2157. triangulation_order3_contour_test
  2158. triangulation_order6_contour, an Octave code which plots color contours of a piecwise quadratic (PWQ) scalar quantity evaluated at the nodes of a 6-node triangle triangulation.
  2159. triangulation_order6_contour_test
  2160. triangulation_plot, an Octave code which plots the nodes and elements of a triangulation as a PostScript file;
  2161. triangulation_plot_test
  2162. triangulation_quad, an Octave code which reads information about a triangulation and the value of a function at the nodes and estimates the integral of the function over the triangulated region.
  2163. triangulation_quad_test
  2164. triangulation_quality, an Octave code which reads information about a triangulation and computes various quality measures;
  2165. triangulation_quality_test
  2166. triangulation_refine, an Octave code which refines a triangulation;
  2167. triangulation_refine_test
  2168. triangulation_svg, an Octave code which creates a Scalable Vector graphics (SVG) image of a triangulation, which can be displayed by a web browser.
  2169. triangulation_svg_test
  2170. triangulation_triangle_neighbors, an Octave code which reads data defining a triangulation, finds the three neighbor triangles for each triangle, and writes them to a file;
  2171. triangulation_triangle_neighbors_test
  2172. tridiagonal_solver, an Octave code which solves a tridiagonal linear system.
  2173. tridiagonal_solver_test
  2174. trig_interp, an Octave code which uses trigonometric functions for interpolation.
  2175. trig_interp_test
  2176. trig_interp_basis, an Octave code which evaluates the cardinal basis functions for trigonometric interpolation of equally spaced data.
  2177. trig_interp_basis_test
  2178. trinity, an Octave code which considers the trinity puzzle, a smaller version of the eternity puzzle. The trinity puzzle specifies a region R composed of 144 30-60-90 triangles, and a set of 4 "tiles", T1, T2, T3 and T4, each consisting of 36 30-60-90 triangles, and seeks an arrangement of the four tiles that exactly covers the region.
  2179. trinity_test
  2180. truel_simulation, an Octave code which simulates N repetitions of a duel between three players, each of whom has a known firing accuracy.
  2181. truel_simulation_test
  2182. truncated_normal, an Octave code which works with the truncated normal distribution over [a,b], or [A,+oo) or (-oo,B], returning the probability density function (PDF), the cumulative density function (CDF), the inverse CDF, the mean, the variance, and sample values.
  2183. truncated_normal_test
  2184. truncated_normal_rule, an Octave code which computes a quadrature rule for a normal probability density function (PDF), sometimes called a Gaussian distribution, that has been truncated to [A,+oo), (-oo,B] or [a,b].
  2185. truncated_normal_rule_test
  2186. truncated_normal_sparse_grid, an Octave code which computes a sparse grid based on a normal probability density function (PDF), also called a Gaussian distribution, that has been truncated to [A,+oo), (-oo,B] or [A,B].
  2187. truncated_normal_sparse_grid_test
  2188. tsp_brute, an Octave code which reads a file of city-to-city distances and solves a (small!) traveling salesperson problem (TSP), using brute force.
  2189. tsp_brute_test
  2190. tsp_descent, an Octave code which reads a file of city-to-city distances, chooses an initial tour at random, and then tries some simple variations to quickly find a tour of lower length, to solve the traveling salesperson problem (TSP).
  2191. tsp_descent_test
  2192. tsp_greedy, an Octave code which reads a file of city-to-city distances, and solves a small traveling salesperson problem (TSP) using the greedy algorithm. It picks a starting city at random, and then successively visits the nearest unvisited city.
  2193. tsp_greedy_test
  2194. tsp_moler, an Octave code which tries to optimize the traveling salesperson problem (TSP), written by Cleve Moler.
  2195. tsp_moler_test
  2196. tsp_random, an Octave code which seeks a solution of the Traveling Salesperson Problem (TSP), by accepting a table of city-to-city distances, and randomly generating round trips that visit every city, returning the tour of shortest length.
  2197. tsp_random_test
  2198. two_body_ode, an Octave code which sets up and solves ordinary differential equations (ODE) which simulate the behavior of two bodies, constrained to lie in a plane, moving under the influence of gravity, with one body much more massive than the other.
  2199. two_body_ode_test
  2200. ubvec, an Octave code which demonstrates how nonnegative integers can be stored as unsigned binary vectors (UBVEC), and arithmetic can be performed on them.
  2201. ubvec_test
  2202. ulam_spiral, an Octave code which displays the integers as a spiral of grid cells, with the primes highlighted, so show that they tend to fall along diagonals, as discovered by Stanislaw Ulam.
  2203. ulam_spiral_test
  2204. unicycle, an Octave code which considers permutations containing a single cycle, sometimes called cyclic permutations.
  2205. unicycle_test
  2206. uniform, an Octave code which implements a uniform random number generator (RNG) for a variety of arithmetic types.
  2207. uniform_test
  2208. unstable_ode, an Octave code which sets up and solves an unstable ordinary differential equation (ODE) which the backward Euler method incorrectly drives to zero.
  2209. unstable_ode_test
  2210. upc, an Octave code which determines the check digit for a Uniform product Code (UPC) or reports whether a given UPC is valid.
  2211. upc_test
  2212. urn_simulation, an Octave code which simulates the experiment of sampling K balls from an urn containing N balls of various colors.
  2213. urn_simulation_test
  2214. usa_box_plot, an Octave code which creates simplified maps of the USA in which each state appears as a box, and the placement of the boxes only roughly corresponds to the relative locations of states on an accurate map.
  2215. usa_box_plot_test
  2216. usa_cvt_geo, an Octave code which explores the creation of a centroidal Voronoi Tessellation (CVT) of the continental United States, based solely on geometric considerations.
  2217. usa_cvt_geo_test
  2218. usa_matrix, an Octave code which defines the adjacency matrix for US states, using a variety of matrix formats.
  2219. usa_matrix_test
  2220. van_der_corput, an Octave code which computes elements of the van der Corput 1-dimensional Quasi Mont Carlo (QMC) sequence, using a simple interface.
  2221. van_der_corput_test
  2222. vandermonde, an Octave code which implements the Bjork-Pereyra algorithm for accurate solution of linear systems involving the Vandermonde matrix.
  2223. vandermonde_test
  2224. vandermonde_approx_1d, an Octave code which finds a polynomial approximant to data y(x) of a 1D argument by setting up and solving an overdetermined linear system for the polynomial coefficients involving the Vandermonde matrix.
  2225. vandermonde_approx_1d_test
  2226. vandermonde_approx_2d, an Octave code which finds a polynomial approximant p(x,y) to data z(x,y) of a 2D argument by setting up and solving an overdetermined linear system for the polynomial coefficients involving the Vandermonde matrix.
  2227. vandermonde_approx_2d_test
  2228. vandermonde_interp_1d, an Octave code which finds a polynomial interpolant to data y(x) of a 1D argument by solving a linear system for the polynomial coefficients involving the Vandermonde matrix.
  2229. vandermonde_interp_1d_test
  2230. vandermonde_interp_2d, an Octave code which finds a polynomial interpolant to data z(x,y) of a 2D argument by solving a linear system for the polynomial coefficients involving the Vandermonde matrix.
  2231. vandermonde_interp_2d_test
  2232. vanderpol_ode, an Octave code which sets up and solves the van der Pol system of ordinary differential equations (ODE).
  2233. vanderpol_ode_test
  2234. vanderpol_ode_period, an Octave code which sets up and solves the ordinary differential equations (ODE) defining the van der Pol oscillator in order to estimate the period of the limit cycle.
  2235. vanderpol_ode_period_test
  2236. variomino, an Octave code which considers variominoes, which are polyominoes in which each square has been assigned a positive label or "variety", and the determination of tilings of a region using a specific set of variominoes.
  2237. variomino_test
  2238. vector, an Octave code which considers a problem involving vectors, which can be considered to belong to equivalence classes, for which an arbitrary collection of coefficients must be gathered, averaged, and then scattered again.
  2239. vector_test
  2240. velocity_verlet, an Octave code which uses a version of the velocity Verlet method to solve a second order ordinary differential equation (ODE) of the form y''=f(t,y).
  2241. velocity_verlet_test
  2242. verlet_simulation, an Octave code which demonstates the use of Verlet integration to simulate simple problems in dynamics, involving changes in position and velocity.
  2243. verlet_simulation_test
  2244. vin, an Octave code which computes the check digit for a Vehicle Identification Number (VIN), or verifies that a given VIN is legitimate.
  2245. vin_test
  2246. voronoi_display, an Octave code which computes and displays the Voronoi diagram of a set of points.
  2247. voronoi_display_test
  2248. voronoi_mountains, an Octave code which makes a mountain plot of a Voronoi diagram, that is, a surface plot of the distance from each point to its nearest Voronoi generator.
  2249. voronoi_mountains_test
  2250. voronoi_neighbors, an Octave code which is given a set of points in the plane and determines the Voronoi adjacency structure, that is, the points which share an edge of the Voronoi diagram.
  2251. voronoi_neighbors_test
  2252. voronoi_plot, an Octave code which estimates the Voronoi neighborhoods of points using sampling, and with a distance based on the L1, L2, LInfinity or arbitrary LP norms;
  2253. voronoi_plot_test
  2254. voronoi_test, an Octave code which calls the built-in voronoi() function, which computes the Voronoi diagram of a set of points.
  2255. vpa_test, an Octave code which uses the Symbolic package to compute arbitrary precision quantities.
  2256. walker_sample, an Octave code which efficiently samples a discrete probability vector using Walker sampling.
  2257. walker_sample_test
  2258. walsh_transform, an Octave code which implements the Walsh data transform.
  2259. walsh_transform_test
  2260. wathen_matrix, an Octave code which compares storage schemes (full, banded, sparse triplet, sparse) and solution strategies (A\x, Linpack, conjugate gradient) for linear systems involving the Wathen matrix, which can arise when solving a problem using the finite element method (FEM).
  2261. wathen_matrix_test
  2262. wave_pde, an Octave code which uses the finite difference method (FDM) in space, and the method of lines in time, to set up and solve the partial differential equations (PDE) known as the wave equations, utt = c uxx.
  2263. wave_pde_test
  2264. wavelet, an Octave code which does some simple calculations with wavelet transforms;
  2265. wavelet_test
  2266. web_matrix, an Octave code which stores sample matrices describing a web page network. These matrices are typically very sparse, and the examples here are stored using the sparse triplet (ST) format. They can be used to demonstrate pagerank and other graph algorithms.
  2267. web_matrix_test
  2268. wedge_exactness, an Octave code which investigates the polynomial exactness of a quadrature rule over the interior of the unit wedge in 3D.
  2269. wedge_exactness_test
  2270. wedge_felippa_rule, an Octave code which returns quadrature rules for approximating integrals over the interior of the unit wedge in 3D.
  2271. wedge_felippa_rule_test
  2272. wedge_grid, an Octave code which computes a grid of points over the interior of the unit wedge in 3D.
  2273. wedge_grid_test
  2274. wedge_integrals, an Octave code which returns the exact value of the integral of any monomial over the interior of the unit wedge in 3D.
  2275. wedge_integrals_test
  2276. wedge_monte_carlo, an Octave code which uses the Monte Carlo method to estimate an integral over the interior of the unit wedge in 3D.
  2277. wedge_monte_carlo_test
  2278. weekday, an Octave code which determines the day of the week corresponding to a given date, such as 14 October 1066, Julian calendar, ... which was a Saturday.
  2279. weekday_test
  2280. weekday_zeller, an Octave code which uses the Zeller congruence to determine the day of the week corresponding to a given date, such as 13 July 1989, Gregorian calendar, ... which was a Thursday.
  2281. weekday_zeller_test
  2282. welzl, an Octave code which computes the minimal bounding circle or sphere for a set of points, using algorithms by Welzl or Ritter, by Anton Semechko.
  2283. welzl_test
  2284. will_you_be_alive, an Octave code which carries out the probability simulations described in "Will You Be Alive 10 Years From Now?" by Paul Nahin;
  2285. will_you_be_alive_test
  2286. wishart_matrix, an Octave code which produces sample matrices from the Wishart or Bartlett distributions, useful for sampling random covariance matrices.
  2287. wishart_matrix_test
  2288. wtime, an Octave code which returns a reading of the wall clock time in seconds.
  2289. wtime_test
  2290. zero_brent, an Octave code which seeks a solution of a scalar nonlinear equation f(x)=0, by Richard Brent.
  2291. zero_brent_test
  2292. zero_chandrupatla, an Octave code which finds a zero of a scalar function of a scalar variable, starting from a change of sign interval, using the Chandrupatla method, which can converge faster than bisection, regula falsi, or Brent's method, by Tirupathi Chandrapatla.
  2293. zero_chandrupatla_test
  2294. zero_itp, an Octave code which finds a zero of a scalar function of a scalar variable, starting from a change of sign interval, using the Interpolate/Truncate/Project (ITP) method, which has faster convergence than the bisection method.
  2295. zero_itp_test
  2296. zero_laguerre, an Octave code which uses Laguerre's method to find the zero of a function. The method needs first and second derivative information. The method almost always works when the function is a polynomial.
  2297. zero_laguerre_test
  2298. zero_muller, an Octave code which seeks a root of a nonlinear equation using the Muller method, with complex arithmetic.
  2299. zero_muller_test
  2300. zero_rc, an Octave code which seeks a solution of a scalar nonlinear equation f(x)=0, using reverse communication (RC), by Richard Brent.
  2301. zero_rc_test
  2302. ziggurat, an Octave code which implements uniform, normal and exponential random number generators (RNG) using the ziggurat method, by Marsaglia and Tsang.
  2303. ziggurat_test
  2304. zombie_ode, an Octave code which sets up and solves a system of ordinary differential equations (ODE) for a generalized Susceptible-Infected-Recovered (SIR) disease model to simulate a zombie attack, developed by Philip Munz.
  2305. zombie_ode_test


Last revised on 02 April 2024.