core/vnl/dll.h [code] | |
core/vnl/vnl_alloc.cxx [code] | |
core/vnl/vnl_alloc.h [code] | Default node allocator |
core/vnl/vnl_analytic_integrant.h [code] | |
core/vnl/vnl_bessel.cxx [code] | Bessel functions of the first kind |
core/vnl/vnl_bessel.h [code] | Bessel functions of the first kind |
core/vnl/vnl_beta.h [code] | Implementation of the beta function, also called the Euler integral of the first kind |
core/vnl/vnl_bignum.cxx [code] | |
core/vnl/vnl_bignum.h [code] | Infinite precision integers |
core/vnl/vnl_bignum_traits.cxx [code] | |
core/vnl/vnl_bignum_traits.h [code] | Numeric traits for vnl_bignum |
core/vnl/vnl_block.cxx [code] | |
core/vnl/vnl_block.h [code] | |
core/vnl/vnl_c_na_vector.h [code] | Math on blocks of memory |
core/vnl/vnl_c_na_vector.txx [code] | |
core/vnl/vnl_c_vector.h [code] | Math on blocks of memory |
core/vnl/vnl_c_vector.txx [code] | |
core/vnl/vnl_complex.h [code] | Complex additions to vnl_math |
core/vnl/vnl_complex_ops.txx [code] | |
core/vnl/vnl_complex_traits.h [code] | To allow templated algorithms to determine appropriate actions of conjugation, complexification etc |
core/vnl/vnl_complexify.h [code] | Functions to create complex vectors and matrices from real ones |
core/vnl/vnl_copy.cxx [code] | |
core/vnl/vnl_copy.h [code] | Easy conversion between vectors and matrices templated over different types |
core/vnl/vnl_cost_function.cxx [code] | |
core/vnl/vnl_cost_function.h [code] | Vector->Real function |
core/vnl/vnl_cross.h [code] | Implements cross product for vectors |
core/vnl/vnl_cross_product_matrix.h [code] | 3x3 cross-product matrix of vector |
core/vnl/vnl_crs_index.cxx [code] | |
core/vnl/vnl_crs_index.h [code] | Compressed Row Storage (CRS) indexing |
core/vnl/vnl_decnum.cxx [code] | |
core/vnl/vnl_decnum.h [code] | Infinite precision numbers with decimal arithmetic |
core/vnl/vnl_decnum_traits.cxx [code] | |
core/vnl/vnl_decnum_traits.h [code] | Numeric traits for vnl_decnum |
core/vnl/vnl_definite_integral.cxx [code] | |
core/vnl/vnl_definite_integral.h [code] | Abstract 1D integrand function used for definite integral |
core/vnl/vnl_det.h [code] | Direct evaluation of 2x2, 3x3 and 4x4 determinants |
core/vnl/vnl_det.txx [code] | |
core/vnl/vnl_diag_matrix.h [code] | Contains class for diagonal matrices |
core/vnl/vnl_diag_matrix.txx [code] | |
core/vnl/vnl_diag_matrix_fixed.h [code] | Contains class for diagonal matrices |
core/vnl/vnl_diag_matrix_fixed.txx [code] | |
core/vnl/vnl_double_1x1.h [code] | 1x1 matrix of double |
core/vnl/vnl_double_1x2.h [code] | 1x2 matrix of double |
core/vnl/vnl_double_1x3.h [code] | 1x3 matrix of double |
core/vnl/vnl_double_2.h [code] | Alias for vnl_vector_fixed<double,2> |
core/vnl/vnl_double_2x1.h [code] | 2x1 matrix of double |
core/vnl/vnl_double_2x2.h [code] | 2x2 matrix of double |
core/vnl/vnl_double_2x3.h [code] | 2x3 matrix of double |
core/vnl/vnl_double_3.h [code] | Contains class vnl_double_3 and function vnl_cross_3d() |
core/vnl/vnl_double_3x1.h [code] | 3x1 matrix of double |
core/vnl/vnl_double_3x2.h [code] | 3x2 matrix of double |
core/vnl/vnl_double_3x3.h [code] | 3x3 matrix of double |
core/vnl/vnl_double_3x4.h [code] | 3x4 Matrix of double |
core/vnl/vnl_double_4.h [code] | Alias for vnl_vector_fixed<double,4> |
core/vnl/vnl_double_4x3.h [code] | 4x3 matrix of double |
core/vnl/vnl_double_4x4.h [code] | 4x4 matrix of double |
core/vnl/vnl_erf.cxx [code] | Complete and incomplete gamma function approximations |
core/vnl/vnl_erf.h [code] | Error Function (erf) approximations |
core/vnl/vnl_error.cxx [code] | Copyright (C) 1991 Texas Instruments Incorporated |
core/vnl/vnl_error.h [code] | |
core/vnl/vnl_fastops.cxx [code] | |
core/vnl/vnl_fastops.h [code] | Collection of C-style matrix functions |
core/vnl/vnl_file_matrix.h [code] | Load vnl_matrix<double> from file |
core/vnl/vnl_file_matrix.txx [code] | |
core/vnl/vnl_file_vector.h [code] | Load vnl_vector<T> from file |
core/vnl/vnl_file_vector.txx [code] | |
core/vnl/vnl_finite.h [code] | Modulo-N arithmetic (finite ring Z_N and Z_N[X]) |
core/vnl/vnl_float_1x1.h [code] | 1x1 matrix of float |
core/vnl/vnl_float_1x2.h [code] | 1x2 matrix of float |
core/vnl/vnl_float_1x3.h [code] | 1x3 matrix of float |
core/vnl/vnl_float_2.h [code] | Contains class vnl_float_2 |
core/vnl/vnl_float_2x1.h [code] | 2x1 matrix of float |
core/vnl/vnl_float_2x2.h [code] | 2x2 matrix of float |
core/vnl/vnl_float_3.h [code] | Contains class vnl_float_3 |
core/vnl/vnl_float_3x1.h [code] | 3x1 matrix of float |
core/vnl/vnl_float_3x3.h [code] | 3x3 matrix of float |
core/vnl/vnl_float_3x4.h [code] | 3x4 matrix of float |
core/vnl/vnl_float_4.h [code] | Contains class vnl_float_4 |
core/vnl/vnl_float_4x3.h [code] | 4x3 matrix of float |
core/vnl/vnl_float_4x4.h [code] | 4x4 matrix of float |
core/vnl/vnl_fortran_copy.h [code] | Convert row-stored matrix to column-stored |
core/vnl/vnl_fortran_copy.txx [code] | |
core/vnl/vnl_fortran_copy_fixed.h [code] | Convert row-stored matrix to column-stored |
core/vnl/vnl_fortran_copy_fixed.txx [code] | |
core/vnl/vnl_fwd.h [code] | |
core/vnl/vnl_gamma.cxx [code] | Complete and incomplete gamma function approximations |
core/vnl/vnl_gamma.h [code] | Complete and incomplete gamma function approximations |
core/vnl/vnl_hungarian_algorithm.h [code] | |
core/vnl/vnl_hungarian_algorithm.txx [code] | |
core/vnl/vnl_identity.h [code] | Contains class vnl_identity |
core/vnl/vnl_identity_3x3.h [code] | Contains class vnl_identity_3x3 |
core/vnl/vnl_imag.h [code] | Functions to return the imaginary parts of complex arrays, vectors, matrices |
core/vnl/vnl_index_sort.h [code] | |
core/vnl/vnl_int_1x1.h [code] | 1x1 matrix of int |
core/vnl/vnl_int_2.h [code] | Contains class vnl_int_2 |
core/vnl/vnl_int_2x2.h [code] | 2x2 matrix of int |
core/vnl/vnl_int_3.h [code] | Alias for vnl_vector_fixed<int,3> |
core/vnl/vnl_int_4.h [code] | Alias for vnl_vector_fixed<int,4> |
core/vnl/vnl_int_matrix.cxx [code] | Vnl_int_matrix Author: Andrew W |
core/vnl/vnl_int_matrix.h [code] | Specializes vnl_matrix for integers |
core/vnl/vnl_integrant_fnct.h [code] | Abstract class of 1D integrand function used in integral |
core/vnl/vnl_inverse.h [code] | Calculates inverse of a small vnl_matrix_fixed (not using svd) |
core/vnl/vnl_least_squares_cost_function.cxx [code] | |
core/vnl/vnl_least_squares_cost_function.h [code] | Vnl_least_squares_function -> vnl_cost_function adaptor |
core/vnl/vnl_least_squares_function.cxx [code] | |
core/vnl/vnl_least_squares_function.h [code] | Abstract base for minimising functions |
core/vnl/vnl_linear_operators_3.h [code] | 3D linear algebra operations |
core/vnl/vnl_linear_system.cxx [code] | |
core/vnl/vnl_linear_system.h [code] | Abstraction for a linear system of equations |
core/vnl/vnl_math.cxx [code] | |
core/vnl/vnl_math.h [code] | Namespace with standard math functions |
core/vnl/vnl_matlab_filewrite.cxx [code] | |
core/vnl/vnl_matlab_filewrite.h [code] | |
core/vnl/vnl_matlab_header.h [code] | MATLAB header structure |
core/vnl/vnl_matlab_print.h [code] | Print matrices and vectors in nice MATLAB format |
core/vnl/vnl_matlab_print.txx [code] | |
core/vnl/vnl_matlab_print2.h [code] | After including this header file, the client should be able to say : |
core/vnl/vnl_matlab_print_format.cxx [code] | |
core/vnl/vnl_matlab_print_format.h [code] | |
core/vnl/vnl_matlab_print_scalar.cxx [code] | |
core/vnl/vnl_matlab_print_scalar.h [code] | |
core/vnl/vnl_matlab_read.cxx [code] | |
core/vnl/vnl_matlab_read.h [code] | Read from MATLAB files |
core/vnl/vnl_matlab_write.cxx [code] | |
core/vnl/vnl_matlab_write.h [code] | Write to a MAT file |
core/vnl/vnl_matops.cxx [code] | |
core/vnl/vnl_matops.h [code] | A collection of Matrix operations |
core/vnl/vnl_matrix.h [code] | An ordinary mathematical matrix |
core/vnl/vnl_matrix.txx [code] | Copyright (C) 1991 Texas Instruments Incorporated |
core/vnl/vnl_matrix_exp.h [code] | Compute the exponential of a square matrix |
core/vnl/vnl_matrix_exp.txx [code] | |
core/vnl/vnl_matrix_fixed.h [code] | Fixed size matrix |
core/vnl/vnl_matrix_fixed.txx [code] | |
core/vnl/vnl_matrix_fixed_ref.h [code] | Fixed size stack-stored vnl_matrix |
core/vnl/vnl_matrix_fixed_ref.txx [code] | |
core/vnl/vnl_matrix_ref.h [code] | Vnl_matrix reference to user-supplied storage |
core/vnl/vnl_na.cxx [code] | |
core/vnl/vnl_na.h [code] | NA (Not Available) is a particular double (or single-precision) NaN to represent missing data |
core/vnl/vnl_nonlinear_minimizer.cxx [code] | |
core/vnl/vnl_nonlinear_minimizer.h [code] | Base class for nonlinear optimization |
core/vnl/vnl_numeric_traits.cxx [code] | |
core/vnl/vnl_numeric_traits.h [code] | Templated zero/one/precision |
core/vnl/vnl_operators.h [code] | Various operators for templated vnl classes |
core/vnl/vnl_polynomial.h [code] | Evaluation of univariate polynomials Templated class (on the data type of the coefficients), further very similar to the vnl_real_polynomial class, except that it uses std::vector instead of vnl_vector as data container, that the zero polynomial is represented by an empty vector, and that the coefficients go in the other direction |
core/vnl/vnl_polynomial.txx [code] | Evaluation of polynomials - the implementation Templated class (on the data type of the coefficients), further very similar to the vnl_real_polynomial class |
core/vnl/vnl_power.h [code] | Calculates nth power of a small vnl_matrix_fixed (not using svd) |
core/vnl/vnl_quaternion.h [code] | Unit quaternion represents rotation in 3D |
core/vnl/vnl_quaternion.txx [code] | Copyright (C) 1992 General Electric Company |
core/vnl/vnl_random.cxx [code] | |
core/vnl/vnl_random.h [code] | A superior random number generator |
core/vnl/vnl_rank.h [code] | Direct computation of the rank of a matrix, without using svd |
core/vnl/vnl_rank.txx [code] | |
core/vnl/vnl_rational.cxx [code] | |
core/vnl/vnl_rational.h [code] | High-precision rational numbers |
core/vnl/vnl_rational_traits.cxx [code] | |
core/vnl/vnl_rational_traits.h [code] | Numeric traits for vnl_rational |
core/vnl/vnl_real.h [code] | Functions to return the real parts of complex arrays, vectors, matrices |
core/vnl/vnl_real_npolynomial.cxx [code] | Degree n real polynomial |
core/vnl/vnl_real_npolynomial.h [code] | Class for polynomials with N variables |
core/vnl/vnl_real_polynomial.cxx [code] | Evaluation of real polynomials - the implementation |
core/vnl/vnl_real_polynomial.h [code] | Evaluation of real polynomials |
core/vnl/vnl_rotation_matrix.cxx [code] | |
core/vnl/vnl_rotation_matrix.h [code] | Functions to create a 3x3 rotation matrix |
core/vnl/vnl_sample.cxx [code] | |
core/vnl/vnl_sample.h [code] | Easy ways to sample from various probability distributions |
core/vnl/vnl_scalar_join_iterator.h [code] | Database join on matrix columns |
core/vnl/vnl_scalar_join_iterator.txx [code] | |
core/vnl/vnl_sparse_lst_sqr_function.cxx [code] | |
core/vnl/vnl_sparse_lst_sqr_function.h [code] | Abstract base for sparse least squares functions |
core/vnl/vnl_sparse_matrix.h [code] | Simple sparse matrix |
core/vnl/vnl_sparse_matrix.txx [code] | |
core/vnl/vnl_sparse_matrix_linear_system.cxx [code] | |
core/vnl/vnl_sparse_matrix_linear_system.h [code] | Vnl_sparse_matrix -> vnl_linear_system adaptor |
core/vnl/vnl_sse.h [code] | Support for Streaming SIMD Extensions to speed up vector arithmetic |
core/vnl/vnl_sym_matrix.h [code] | Contains class for symmetric matrices |
core/vnl/vnl_sym_matrix.txx [code] | |
core/vnl/vnl_T_n.h [code] | |
core/vnl/vnl_tag.h [code] | |
core/vnl/vnl_trace.h [code] | Calculate trace of a matrix |
core/vnl/vnl_transpose.h [code] | Efficient matrix transpose |
core/vnl/vnl_unary_function.h [code] | Abstract 1D map |
core/vnl/vnl_unary_function.txx [code] | Abstract 1D map vnl_unary_function is an abstract map between two types (read spaces) |
core/vnl/vnl_vector.h [code] | |
core/vnl/vnl_vector.txx [code] | New lite version adapted from Matrix.h |
core/vnl/vnl_vector_fixed.h [code] | Fixed length stack-stored vector |
core/vnl/vnl_vector_fixed.txx [code] | |
core/vnl/vnl_vector_fixed_ref.h [code] | Fixed size vnl_vector using user-supplied storage See vnl_matrix_fixed_ref for rationale |
core/vnl/vnl_vector_fixed_ref.txx [code] | |
core/vnl/vnl_vector_ref.h [code] | Vnl_vector using user-supplied storage |
core/vnl/algo/dll.h [code] | |
core/vnl/algo/vnl_adaptsimpson_integral.cxx [code] | |
core/vnl/algo/vnl_adaptsimpson_integral.h [code] | |
core/vnl/algo/vnl_adjugate.h [code] | |
core/vnl/algo/vnl_adjugate.txx [code] | |
core/vnl/algo/vnl_algo_fwd.h [code] | |
core/vnl/algo/vnl_amoeba.cxx [code] | |
core/vnl/algo/vnl_amoeba.h [code] | Nelder-Meade downhill simplex |
core/vnl/algo/vnl_bracket_minimum.cxx [code] | Function to bracket a minimum |
core/vnl/algo/vnl_bracket_minimum.h [code] | Function to bracket a minimum |
core/vnl/algo/vnl_brent.cxx [code] | |
core/vnl/algo/vnl_brent.h [code] | |
core/vnl/algo/vnl_brent_minimizer.cxx [code] | |
core/vnl/algo/vnl_brent_minimizer.h [code] | |
core/vnl/algo/vnl_chi_squared.h [code] | Name space for various (mostly templated) chi-squared distribution functions |
core/vnl/algo/vnl_chi_squared.txx [code] | |
core/vnl/algo/vnl_cholesky.cxx [code] | Vnl_cholesky |
core/vnl/algo/vnl_cholesky.h [code] | Decomposition of symmetric matrix |
core/vnl/algo/vnl_complex_eigensystem.cxx [code] | |
core/vnl/algo/vnl_complex_eigensystem.h [code] | Calculates eigenvalues and eigenvectors of a square complex matrix |
core/vnl/algo/vnl_complex_generalized_schur.cxx [code] | |
core/vnl/algo/vnl_complex_generalized_schur.h [code] | Solves the generalized eigenproblem det(t A - s B) = 0 |
core/vnl/algo/vnl_conjugate_gradient.cxx [code] | |
core/vnl/algo/vnl_conjugate_gradient.h [code] | Real function minimization |
core/vnl/algo/vnl_convolve.h [code] | Templated 1D and 2D convolution |
core/vnl/algo/vnl_convolve.txx [code] | |
core/vnl/algo/vnl_cpoly_roots.cxx [code] | |
core/vnl/algo/vnl_cpoly_roots.h [code] | Finds roots of a univariate polynomial with complex coefficients |
core/vnl/algo/vnl_determinant.cxx [code] | |
core/vnl/algo/vnl_determinant.h [code] | Calculates the determinant of a matrix |
core/vnl/algo/vnl_determinant.txx [code] | |
core/vnl/algo/vnl_discrete_diff.cxx [code] | |
core/vnl/algo/vnl_discrete_diff.h [code] | Functions to compute jacobians of vnl_least_squares_functions |
core/vnl/algo/vnl_fft.cxx [code] | |
core/vnl/algo/vnl_fft.h [code] | |
core/vnl/algo/vnl_fft_1d.h [code] | In-place 1D fast Fourier transform |
core/vnl/algo/vnl_fft_1d.txx [code] | |
core/vnl/algo/vnl_fft_2d.h [code] | In-place 2D fast Fourier transform |
core/vnl/algo/vnl_fft_2d.txx [code] | |
core/vnl/algo/vnl_fft_base.h [code] | In-place n-D fast Fourier transform |
core/vnl/algo/vnl_fft_base.txx [code] | |
core/vnl/algo/vnl_fft_prime_factors.h [code] | Holds prime factor information |
core/vnl/algo/vnl_fft_prime_factors.txx [code] | |
core/vnl/algo/vnl_fit_parabola.h [code] | Function to fit a parabola to three point to predict the centre line |
core/vnl/algo/vnl_gaussian_kernel_1d.cxx [code] | |
core/vnl/algo/vnl_gaussian_kernel_1d.h [code] | Holds one half of a discretely sampled 1D gaussian distribution |
core/vnl/algo/vnl_generalized_eigensystem.cxx [code] | |
core/vnl/algo/vnl_generalized_eigensystem.h [code] | Solves the generalized eigenproblem Ax=La |
core/vnl/algo/vnl_generalized_schur.cxx [code] | |
core/vnl/algo/vnl_generalized_schur.h [code] | Solves the generalized eigenproblem det(t A - s B) = 0 |
core/vnl/algo/vnl_lbfgs.cxx [code] | |
core/vnl/algo/vnl_lbfgs.h [code] | Limited memory Broyden Fletcher Goldfarb Shannon minimization |
core/vnl/algo/vnl_lbfgsb.cxx [code] | |
core/vnl/algo/vnl_lbfgsb.h [code] | Limited memory Broyden Fletcher Goldfarb Shannon constrained opt |
core/vnl/algo/vnl_ldl_cholesky.cxx [code] | Updateable Cholesky decomposition: A=LDL' |
core/vnl/algo/vnl_ldl_cholesky.h [code] | Updateable Cholesky decomposition: A=LDL' |
core/vnl/algo/vnl_levenberg_marquardt.cxx [code] | |
core/vnl/algo/vnl_levenberg_marquardt.h [code] | Levenberg Marquardt nonlinear least squares |
core/vnl/algo/vnl_lsqr.cxx [code] | |
core/vnl/algo/vnl_lsqr.h [code] | Linear least squares |
core/vnl/algo/vnl_matrix_inverse.h [code] | Calculates inverse of a matrix (wrapper around vnl_svd<double>) |
core/vnl/algo/vnl_matrix_inverse.txx [code] | |
core/vnl/algo/vnl_matrix_update.h [code] | Function to compute M=M+a*b' |
core/vnl/algo/vnl_netlib.h [code] | Declare in a central place the list of symbols from netlib |
core/vnl/algo/vnl_orthogonal_complement.h [code] | For computing the orthogonal complement to a linear subspace |
core/vnl/algo/vnl_orthogonal_complement.txx [code] | |
core/vnl/algo/vnl_powell.cxx [code] | |
core/vnl/algo/vnl_powell.h [code] | Powell minimizer |
core/vnl/algo/vnl_qr.h [code] | Calculate inverse of a matrix using QR |
core/vnl/algo/vnl_qr.txx [code] | |
core/vnl/algo/vnl_real_eigensystem.cxx [code] | |
core/vnl/algo/vnl_real_eigensystem.h [code] | Extract eigensystem of non-symmetric matrix M, using EISPACK |
core/vnl/algo/vnl_rnpoly_solve.cxx [code] | |
core/vnl/algo/vnl_rnpoly_solve.h [code] | Solves for roots of system of real polynomials |
core/vnl/algo/vnl_rpoly_roots.cxx [code] | |
core/vnl/algo/vnl_rpoly_roots.h [code] | Finds roots of a real polynomial |
core/vnl/algo/vnl_scatter_3x3.h [code] | 3x3 scatter matrix |
core/vnl/algo/vnl_scatter_3x3.txx [code] | |
core/vnl/algo/vnl_simpson_integral.cxx [code] | |
core/vnl/algo/vnl_simpson_integral.h [code] | |
core/vnl/algo/vnl_solve_qp.cxx [code] | Functions to solve various forms of constrained quadratic programming |
core/vnl/algo/vnl_solve_qp.h [code] | Functions to solve various forms of constrained quadratic programming |
core/vnl/algo/vnl_sparse_lm.cxx [code] | |
core/vnl/algo/vnl_sparse_lm.h [code] | Sparse Levenberg Marquardt nonlinear least squares |
core/vnl/algo/vnl_sparse_lu.cxx [code] | |
core/vnl/algo/vnl_sparse_lu.h [code] | Solution of the linear system Mx = b for sparse matrices |
core/vnl/algo/vnl_sparse_symmetric_eigensystem.cxx [code] | |
core/vnl/algo/vnl_sparse_symmetric_eigensystem.h [code] | Find the eigenvalues of a sparse symmetric matrix |
core/vnl/algo/vnl_svd.h [code] | Holds the singular value decomposition of a vnl_matrix |
core/vnl/algo/vnl_svd.txx [code] | |
core/vnl/algo/vnl_svd_economy.h [code] | SVD wrapper that doesn't compute the left singular vectors, U |
core/vnl/algo/vnl_svd_economy.txx [code] | |
core/vnl/algo/vnl_svd_fixed.h [code] | Holds the singular value decomposition of a vnl_matrix_fixed |
core/vnl/algo/vnl_svd_fixed.txx [code] | |
core/vnl/algo/vnl_symmetric_eigensystem.h [code] | Find eigenvalues of a symmetric matrix |
core/vnl/algo/vnl_symmetric_eigensystem.txx [code] | |
core/vnl/io/vnl_io_bignum.cxx [code] | |
core/vnl/io/vnl_io_bignum.h [code] | |
core/vnl/io/vnl_io_diag_matrix.h [code] | |
core/vnl/io/vnl_io_diag_matrix.txx [code] | |
core/vnl/io/vnl_io_matrix.h [code] | |
core/vnl/io/vnl_io_matrix.txx [code] | |
core/vnl/io/vnl_io_matrix_fixed.h [code] | |
core/vnl/io/vnl_io_matrix_fixed.txx [code] | |
core/vnl/io/vnl_io_nonlinear_minimizer.cxx [code] | |
core/vnl/io/vnl_io_nonlinear_minimizer.h [code] | |
core/vnl/io/vnl_io_rational.cxx [code] | |
core/vnl/io/vnl_io_rational.h [code] | |
core/vnl/io/vnl_io_real_npolynomial.cxx [code] | |
core/vnl/io/vnl_io_real_npolynomial.h [code] | |
core/vnl/io/vnl_io_real_polynomial.cxx [code] | |
core/vnl/io/vnl_io_real_polynomial.h [code] | |
core/vnl/io/vnl_io_sparse_matrix.h [code] | |
core/vnl/io/vnl_io_sparse_matrix.txx [code] | |
core/vnl/io/vnl_io_sym_matrix.h [code] | |
core/vnl/io/vnl_io_sym_matrix.txx [code] | |
core/vnl/io/vnl_io_vector.h [code] | |
core/vnl/io/vnl_io_vector.txx [code] | |
core/vnl/io/vnl_io_vector_fixed.h [code] | |
core/vnl/io/vnl_io_vector_fixed.txx [code] | |
core/vnl/xio/vnl_xio_matrix.h [code] | XML write a vnl_matrix Two functions which write a valid XML fragment to an ostream |
core/vnl/xio/vnl_xio_matrix.txx [code] | |
core/vnl/xio/vnl_xio_matrix_fixed.h [code] | XML write a vnl_matrix_fixed Two functions which write a valid XML fragment to an ostream |
core/vnl/xio/vnl_xio_matrix_fixed.txx [code] | |
core/vnl/xio/vnl_xio_quaternion.h [code] | XML write a vnl_quaternion Two functions which write a valid XML fragment to an ostream |
core/vnl/xio/vnl_xio_quaternion.txx [code] | |
core/vnl/xio/vnl_xio_vector.h [code] | XML write a vnl_vector Two functions which write a valid XML fragment to an ostream |
core/vnl/xio/vnl_xio_vector.txx [code] | |
core/vnl/xio/vnl_xio_vector_fixed.h [code] | XML write a vnl_vector_fixed Two functions which write a valid XML fragment to an ostream |
core/vnl/xio/vnl_xio_vector_fixed.txx [code] | |