├── readme ├── startup.m ├── toolbox_alpert ├── build_alpert_matrix_1d.m ├── build_alpert_matrix_2d.m ├── compile_mex.m ├── content.m ├── dichotomic_grouping.m ├── html │ ├── content.html │ ├── content.png │ ├── content_01.png │ ├── content_02.png │ ├── content_03.png │ ├── content_04.png │ ├── content_05.png │ ├── content_06.png │ ├── content_07.png │ ├── gpeyre.xsl │ └── style.css ├── mex │ ├── config.h │ ├── gram_schmidt.h │ ├── matrix.h │ ├── perform_moment_transform.cpp │ ├── perform_moment_transform.def │ ├── perform_moment_transform.h │ ├── perform_moment_transform.vcproj │ ├── perform_moment_transform_mex.cpp │ └── toolbox_alpert.sln ├── perform_alpert_transform_1d.m ├── perform_alpert_transform_2d.m ├── perform_alpert_transform_2d_sliced.m ├── perform_alpert_transform_nd.m ├── perform_moment_transform.dll ├── perform_moment_transform_slow.m ├── plot_dichotomic_partition.m ├── plot_spherical_function.m ├── plot_spherical_partition.m ├── publish_html.m ├── sphere_sampling.m ├── tests │ ├── test_decreasing_1d.m │ ├── test_decreasing_2d.m │ ├── test_decreasing_nd.m │ ├── test_grouping.m │ ├── test_image.m │ ├── test_mex.m │ ├── test_plot_1d.m │ ├── test_plot_2d.m │ ├── test_speed_2d.m │ ├── test_spherical.m │ └── test_warpsampling.m └── toolbox │ ├── array_get_val.m │ ├── array_set_val.m │ ├── clamp.m │ ├── compute_distance_to_points.m │ ├── crop.m │ ├── dirac.m │ ├── gen_base_mesh.m │ ├── gen_signal.m │ ├── gen_signal_2d.m │ ├── get_color_from_index.m │ ├── getoptions.m │ ├── imageplot.m │ ├── keep_biggest.m │ ├── l2error.m │ ├── lena.png │ ├── load_image.m │ ├── load_signal.m │ ├── mmax.m │ ├── mmin.m │ ├── norme.m │ ├── plot_scattered.m │ ├── plot_wavelet.m │ ├── rescale.m │ ├── rev_sort_abs.m │ ├── reverse_permutation.m │ └── subdivide_sphere.m ├── toolbox_curve ├── compute_bezier_curve.m ├── compute_cuvilinear_abscice.m ├── compute_hausdorff_distance.m ├── gen_levy_flight.m ├── gen_rand_curve.m ├── hilbert_curve.m ├── integrate_along_curve.m ├── load_curve.m ├── meshless_closed_curve_reconstruction.m ├── meshless_curve_reconstruction.m ├── peano_curve.m ├── perform_contour_extraction.m ├── perform_curve_extraction.m ├── perform_curve_resampling.m ├── perform_curve_warping.m ├── perform_normal_curve_transform.m ├── plot_curve.m ├── publish_html.m ├── split_curve.m ├── tests │ ├── test_bezier.m │ ├── test_levy_flight.m │ ├── test_normal_curves.m │ └── test_peano.m └── toolbox │ ├── getoptions.m │ └── keep_biggest.m ├── toolbox_diffc ├── compute_crossp_vf_vf.m ├── compute_deviator_tensor.m ├── compute_diff.m ├── compute_flow.m ├── compute_grad.m ├── compute_gradient_tensor.m ├── compute_hessian.m ├── compute_hodge_decompositon.m ├── compute_laplacian.m ├── compute_local_maxima.m ├── compute_operator_1.m ├── compute_operator_2.m ├── compute_rigidity_tensor.m ├── compute_structure_tensor.m ├── compute_tensor_field.m ├── compute_tensor_field_random.m ├── compute_vf_angle.m ├── compute_vf_polar_dec.m ├── compute_vf_trajectory.m ├── content.m ├── data │ └── sparse-curve.png ├── div.m ├── grad.m ├── html │ ├── content.html │ ├── content.png │ ├── content_01.png │ ├── content_02.png │ ├── content_03.png │ ├── content_04.png │ ├── content_05.png │ ├── gpeyre.xsl │ └── style.css ├── load_flow.m ├── perform_angle_doubling.m ├── perform_conjugate_gradient.m ├── perform_fluid_dynamics.m ├── perform_image_advection.m ├── perform_orientation_diffusion.m ├── perform_tensor_decomp.m ├── perform_tensor_decomp_3d.m ├── perform_tensor_eigendecomposition.m ├── perform_tensor_mapping.m ├── perform_tensor_recomp.m ├── perform_vf_integration.m ├── perform_vf_normalization.m ├── perform_vf_reorientation.m ├── plot_tensor_field.m ├── plot_tensor_field_nb.m ├── plot_tf.m ├── plot_vf.m ├── plot_vf_scaterred.m ├── prod_tf_sf.m ├── prod_tf_tf.m ├── prod_tf_vf.m ├── prod_vf_sf.m ├── prod_vf_vf.m ├── publish_html.m ├── tests │ ├── test_cg.m │ ├── test_diffc.m │ ├── test_div_grad.m │ ├── test_flow.m │ ├── test_hessian.m │ ├── test_incompressible_fluid.m │ ├── test_orientation_diffusion.m │ ├── test_singular_points.m │ ├── test_structure_tensor.m │ ├── test_tensor_3d.m │ ├── test_texture_advection.m │ ├── test_vf_integration.m │ └── test_vf_reorientation.m ├── toolbox │ ├── clamp.m │ ├── compute_gaussian_filter.m │ ├── compute_movie_file.m │ ├── compute_periodic_poisson.m │ ├── crop.m │ ├── getoptions.m │ ├── imageplot.m │ ├── lena.png │ ├── load_image.m │ ├── nb_dims.m │ ├── perform_blurring.m │ ├── perform_convolution.m │ ├── perform_histogram_equalization.m │ ├── progressbar.m │ └── rescale.m └── toolbox_diffc.m ├── toolbox_dimreduc ├── addchv.dll ├── addchv.mexmaci ├── compile_mex.m ├── compute_nearest_neighbors.m ├── compute_nn_distance.m ├── compute_nn_graph.m ├── copying ├── copyright ├── corrsum.mexmaci ├── corrsum2.mexmaci ├── data │ ├── frey_rawface.mat │ └── nefertiti.off ├── dijkstra_fast.dll ├── emb_brute_nn.mexmaci ├── hlle.m ├── isomap.m ├── leigs.m ├── lle.m ├── load_images_dataset.m ├── load_points_set.m ├── load_subimages_dataset.m ├── ltsa.m ├── mex │ └── addchv.c ├── nn_brute.mexmaci ├── nn_prepare.dll ├── nn_prepare.m ├── nn_prepare.mexmaci ├── nn_search.dll ├── nn_search.m ├── nn_search.mexmaci ├── pca.m ├── perform_diffusion_mapping.m ├── perform_dimreduc_interpolation.m ├── perform_geodesic_embedding.m ├── perform_local_pca.m ├── plot_flattened_dataset.m ├── range_brute.mexmaci ├── range_search.dll ├── range_search.m ├── range_search.mexmaci ├── readme ├── tests │ ├── test_datasets.m │ ├── test_dimreduc.m │ ├── test_display_pointsets.m │ ├── test_images.m │ ├── test_isomap_landmarks.m │ ├── test_meshes.m │ ├── test_nearest_neighboors.m │ ├── test_pca.m │ └── test_subimages.m └── toolbox │ ├── build_euclidean_weight_matrix.m │ ├── compute_distance_matrix.m │ ├── compute_distance_to_points.m │ ├── getoptions.m │ ├── load_image.m │ ├── mmax.m │ ├── perform_rbf_interpolation.m │ ├── plot_graph.m │ ├── plot_mesh.m │ ├── plot_scattered.m │ ├── read_off.m │ ├── rescale.m │ ├── test_rbf.m │ └── triangulation2adjacency.m ├── toolbox_fast_marching ├── batch_landmarks_error.m ├── batch_propagation_mesh.m ├── batch_shape_meshing.m ├── callback_active_contour.m ├── compile_mex.m ├── compute_alpha_map.m ├── compute_bending_invariant.m ├── compute_distance_landmark.m ├── compute_eccentricity_transform.m ├── compute_edge_energy.m ├── compute_geodesic.m ├── compute_geodesic_mesh.m ├── compute_heuristic_landmark.m ├── compute_heuristic_multiresolution.m ├── compute_levelset_shape.m ├── compute_saddle_points.m ├── compute_shape_boundary.m ├── compute_voronoi_triangulation.m ├── compute_voronoi_triangulation_mesh.m ├── content.m ├── convert_distance_color.m ├── data │ ├── apple.gif │ ├── brain.png │ ├── camel.gif │ ├── cavern.png │ ├── chan-vese.jpg │ ├── chicken.gif │ ├── elephant-50kv.off │ ├── giraffe.gif │ ├── image01.tiff │ ├── mm.png │ ├── mountain.png │ ├── road2.png │ ├── room.png │ ├── room1.png │ └── stephanodiscusniagarae.jpg ├── display_eccentricity.m ├── display_segmentation.m ├── divgrad.m ├── eucdist2.dll ├── eucdist2.m ├── eucdist2.mexglx ├── eucdist2.mexmaci ├── fm2dAniso.mexmaci ├── generate_constrained_map.m ├── html │ ├── content.html │ ├── content.png │ ├── content_01.png │ ├── content_02.png │ ├── content_03.png │ ├── content_04.png │ ├── content_05.png │ ├── content_06.png │ ├── content_07.png │ ├── content_08.png │ ├── content_09.png │ ├── content_10.png │ ├── content_11.png │ ├── gpeyre.xsl │ └── style.css ├── load_potential_map.m ├── mesh.poly ├── mex │ ├── anisotropic-fm-feth │ │ ├── fm.h │ │ ├── fm2dAniso.cpp │ │ ├── fm2dAniso.h │ │ ├── fm2dAniso.mexmaci │ │ └── testFM2dAniso.m │ ├── backup │ │ ├── perform_front_propagation_2d.cpp │ │ ├── perform_front_propagation_3d - copie.cpp │ │ ├── perform_front_propagation_3d_old.cpp │ │ └── perform_front_propagation_anisotropic.cpp │ ├── config.h │ ├── eucdist2.c │ ├── fheap │ │ ├── fib.cpp │ │ ├── fib.h │ │ ├── fibpriv.h │ │ ├── fibtest.c │ │ ├── fibtest2.c │ │ ├── tt.c │ │ └── use.c │ ├── gw │ │ ├── gw.sln │ │ ├── gw.suo │ │ ├── gw_core │ │ │ ├── GW_Config.cpp │ │ │ ├── GW_Config.h │ │ │ ├── GW_Face.cpp │ │ │ ├── GW_Face.h │ │ │ ├── GW_Face.inl │ │ │ ├── GW_FaceIterator.cpp │ │ │ ├── GW_FaceIterator.h │ │ │ ├── GW_MathsWrapper.h │ │ │ ├── GW_Mesh.cpp │ │ │ ├── GW_Mesh.h │ │ │ ├── GW_Mesh.inl │ │ │ ├── GW_PolygonIntersector.h │ │ │ ├── GW_ProgressBar.h │ │ │ ├── GW_Serializable.h │ │ │ ├── GW_SmartCounter.cpp │ │ │ ├── GW_SmartCounter.h │ │ │ ├── GW_SmartCounter.inl │ │ │ ├── GW_Vertex.cpp │ │ │ ├── GW_Vertex.h │ │ │ ├── GW_Vertex.inl │ │ │ ├── GW_VertexIterator.cpp │ │ │ ├── GW_VertexIterator.h │ │ │ ├── gw_core.vcproj │ │ │ ├── stdafx.cpp │ │ │ └── stdafx.h │ │ ├── gw_geodesic │ │ │ ├── GW_GeodesicFace.cpp │ │ │ ├── GW_GeodesicFace.h │ │ │ ├── GW_GeodesicFace.inl │ │ │ ├── GW_GeodesicMesh.cpp │ │ │ ├── GW_GeodesicMesh.h │ │ │ ├── GW_GeodesicMesh.inl │ │ │ ├── GW_GeodesicPath.cpp │ │ │ ├── GW_GeodesicPath.h │ │ │ ├── GW_GeodesicPath.inl │ │ │ ├── GW_GeodesicPoint.cpp │ │ │ ├── GW_GeodesicPoint.h │ │ │ ├── GW_GeodesicPoint.inl │ │ │ ├── GW_GeodesicVertex.cpp │ │ │ ├── GW_GeodesicVertex.h │ │ │ ├── GW_GeodesicVertex.inl │ │ │ ├── GW_GeometryAtlas.cpp │ │ │ ├── GW_GeometryAtlas.h │ │ │ ├── GW_GeometryAtlas.inl │ │ │ ├── GW_GeometryCell.cpp │ │ │ ├── GW_GeometryCell.h │ │ │ ├── GW_GeometryCell.inl │ │ │ ├── GW_Parameterization.cpp │ │ │ ├── GW_Parameterization.h │ │ │ ├── GW_Parameterization.inl │ │ │ ├── GW_TriangularInterpolation.cpp │ │ │ ├── GW_TriangularInterpolation.h │ │ │ ├── GW_TriangularInterpolation.inl │ │ │ ├── GW_TriangularInterpolation_ABC.h │ │ │ ├── GW_TriangularInterpolation_Cubic.cpp │ │ │ ├── GW_TriangularInterpolation_Cubic.h │ │ │ ├── GW_TriangularInterpolation_Cubic.inl │ │ │ ├── GW_TriangularInterpolation_Linear.cpp │ │ │ ├── GW_TriangularInterpolation_Linear.h │ │ │ ├── GW_TriangularInterpolation_Linear.inl │ │ │ ├── GW_TriangularInterpolation_Quadratic.cpp │ │ │ ├── GW_TriangularInterpolation_Quadratic.h │ │ │ ├── GW_TriangularInterpolation_Quadratic.inl │ │ │ ├── GW_VoronoiMesh.cpp │ │ │ ├── GW_VoronoiMesh.h │ │ │ ├── GW_VoronoiMesh.inl │ │ │ ├── GW_VoronoiVertex.cpp │ │ │ ├── GW_VoronoiVertex.h │ │ │ ├── GW_VoronoiVertex.inl │ │ │ ├── gw_geodesic.vcproj │ │ │ ├── stdafx.cpp │ │ │ └── stdafx.h │ │ ├── gw_maths │ │ │ ├── GW_Maths.h │ │ │ ├── GW_MathsConfig.h │ │ │ ├── GW_Matrix2x2.h │ │ │ ├── GW_Matrix3x3.h │ │ │ ├── GW_Matrix4x4.h │ │ │ ├── GW_MatrixNxP.h │ │ │ ├── GW_MatrixStatic.h │ │ │ ├── GW_Quaternion.h │ │ │ ├── GW_SparseMatrix.h │ │ │ ├── GW_Vector2D.h │ │ │ ├── GW_Vector3D.h │ │ │ ├── GW_Vector4D.h │ │ │ ├── GW_VectorND.h │ │ │ ├── GW_VectorStatic.h │ │ │ ├── gw_complex.h │ │ │ ├── test │ │ │ │ ├── main.cpp │ │ │ │ └── test.vcproj │ │ │ └── tnt │ │ │ │ ├── jama_cholesky.h │ │ │ │ ├── jama_eig.h │ │ │ │ ├── jama_lu.h │ │ │ │ ├── jama_qr.h │ │ │ │ ├── jama_svd.h │ │ │ │ ├── tnt.h │ │ │ │ ├── tnt_array1d.h │ │ │ │ ├── tnt_array1d_utils.h │ │ │ │ ├── tnt_array2d.h │ │ │ │ ├── tnt_array2d_utils.h │ │ │ │ ├── tnt_array3d.h │ │ │ │ ├── tnt_array3d_utils.h │ │ │ │ ├── tnt_cmat.h │ │ │ │ ├── tnt_fortran_array1d.h │ │ │ │ ├── tnt_fortran_array1d_utils.h │ │ │ │ ├── tnt_fortran_array2d.h │ │ │ │ ├── tnt_fortran_array2d_utils.h │ │ │ │ ├── tnt_fortran_array3d.h │ │ │ │ ├── tnt_fortran_array3d_utils.h │ │ │ │ ├── tnt_math_utils.h │ │ │ │ ├── tnt_sparse_matrix_csr.h │ │ │ │ ├── tnt_stopwatch.h │ │ │ │ ├── tnt_subscript.h │ │ │ │ ├── tnt_vec.h │ │ │ │ └── tnt_version.h │ │ └── gw_toolkit │ │ │ ├── GW_ASELoader.cpp │ │ │ ├── GW_ASELoader.h │ │ │ ├── GW_BasicDisplayer.cpp │ │ │ ├── GW_BasicDisplayer.h │ │ │ ├── GW_BasicDisplayer.inl │ │ │ ├── GW_CSVLoader.h │ │ │ ├── GW_GeodesicDisplayer.cpp │ │ │ ├── GW_GeodesicDisplayer.h │ │ │ ├── GW_GeodesicDisplayer.inl │ │ │ ├── GW_InputOutput.cpp │ │ │ ├── GW_InputOutput.h │ │ │ ├── GW_OBJLoader.cpp │ │ │ ├── GW_OBJLoader.h │ │ │ ├── GW_OFFLoader.cpp │ │ │ ├── GW_OFFLoader.h │ │ │ ├── GW_OpenGLHelper.h │ │ │ ├── GW_PLYLoader.cpp │ │ │ ├── GW_PLYLoader.h │ │ │ ├── GW_Toolkit.cpp │ │ │ ├── GW_Toolkit.h │ │ │ ├── GW_VRMLLoader.cpp │ │ │ ├── GW_VRMLLoader.h │ │ │ ├── gw_toolkit.vcproj │ │ │ ├── ply │ │ │ ├── ply.c │ │ │ ├── ply.h │ │ │ ├── ply_docs │ │ │ ├── plyfile.cpp │ │ │ └── plytest.c │ │ │ ├── stdafx.cpp │ │ │ ├── stdafx.h │ │ │ ├── trackball.cpp │ │ │ └── trackball.h │ ├── perform_circular_front_propagation_2d.cpp │ ├── perform_circular_front_propagation_2d.def │ ├── perform_circular_front_propagation_2d.vcproj │ ├── perform_front_propagation.sln │ ├── perform_front_propagation_2d.cpp │ ├── perform_front_propagation_2d.def │ ├── perform_front_propagation_2d.h │ ├── perform_front_propagation_2d.vcproj │ ├── perform_front_propagation_2d_mex.cpp │ ├── perform_front_propagation_3d.cpp │ ├── perform_front_propagation_3d.def │ ├── perform_front_propagation_3d.h │ ├── perform_front_propagation_3d.vcproj │ ├── perform_front_propagation_3d_mex.cpp │ ├── perform_front_propagation_anisotropic.cpp │ ├── perform_front_propagation_mesh.cpp │ ├── perform_front_propagation_mesh.def │ ├── perform_front_propagation_mesh.vcproj │ └── skeleton.cpp ├── perform_active_contour.m ├── perform_circular_fast_marching_2d.m ├── perform_circular_front_propagation_2d.mexmaci ├── perform_farthest_landmark_sampling.m ├── perform_farthest_point_sampling.m ├── perform_farthest_point_sampling_boundary.m ├── perform_farthest_point_sampling_mesh.m ├── perform_fast_marching.m ├── perform_fast_marching_mesh.m ├── perform_fast_marching_old.m ├── perform_fmstar_2d.m ├── perform_fmstar_3d.m ├── perform_front_propagation_2d.m ├── perform_front_propagation_2d.mexmaci ├── perform_front_propagation_2d_slow.m ├── perform_front_propagation_3d.mexmaci ├── perform_front_propagation_anisotropic.mexmaci ├── perform_front_propagation_mesh.mexmaci ├── perform_geodesic_interpolation.m ├── perform_lloyd_mesh.m ├── perform_redistancing.m ├── pick_curves.m ├── pick_start_end_point.m ├── plot_constrained_path_planing.m ├── plot_fast_marching_2d.m ├── plot_fast_marching_3d.m ├── plot_fast_marching_mesh.m ├── plot_volumetric_data.m ├── publish_html.m ├── readme ├── skeleton.dll ├── skeleton.mexmaci ├── tests │ ├── test_active_contour.m │ ├── test_anisotropic.m │ ├── test_anisotropic_feth.m │ ├── test_anisotropic_fm.m │ ├── test_anisotropic_fm_old.m │ ├── test_bending_invariants.m │ ├── test_bug.m │ ├── test_circular.m │ ├── test_circular_fast_marching_2d.m │ ├── test_circular_prior.m │ ├── test_constrained_map.m │ ├── test_distance_approximation.m │ ├── test_distance_compression.m │ ├── test_eccentricity.m │ ├── test_eucldist.m │ ├── test_farthest_sampling_2d.m │ ├── test_farthest_sampling_3d.m │ ├── test_farthest_sampling_mesh.m │ ├── test_farthest_sampling_shape.m │ ├── test_fast_marching_2d.m │ ├── test_fast_marching_3d.m │ ├── test_fmstar_2d.m │ ├── test_fmstar_3d.m │ ├── test_fmstar_error.m │ ├── test_fmstar_landmark.m │ ├── test_fmstar_path_planing.m │ ├── test_fmstar_weight_2d.m │ ├── test_geodesic_interpolation.m │ ├── test_geodesic_vs_euclidean.m │ ├── test_heuristic_mesh.m │ ├── test_influence.m │ ├── test_landmark.m │ ├── test_landmark_error.m │ ├── test_multiple_paths_2d.m │ ├── test_multiple_paths_3d.m │ ├── test_path_planing.m │ ├── test_propagation_2d.m │ ├── test_propagation_mesh.m │ ├── test_propagation_shape.m │ ├── test_redistancing.m │ ├── test_segmentation.m │ ├── test_skeleton.m │ ├── test_vol3d.m │ ├── test_voronoi_segmentation.m │ └── test_voronoi_triangulation.m ├── toolbox │ ├── check_face_vertex.m │ ├── clamp.m │ ├── compute_cuvilinear_abscice.m │ ├── compute_distance_to_points.m │ ├── compute_edge_face_ring.m │ ├── compute_edges.m │ ├── compute_gaussian_filter.m │ ├── compute_grad.m │ ├── compute_vertex_ring.m │ ├── crop.m │ ├── getoptions.m │ ├── imageplot.m │ ├── load_image.m │ ├── mmax.m │ ├── nb_dims.m │ ├── num2string_fixeddigit.m │ ├── perform_blurring.m │ ├── perform_conjugate_gradient.m │ ├── perform_contour_extraction.m │ ├── perform_convolution.m │ ├── perform_curve_extraction.m │ ├── perform_curve_resampling.m │ ├── perform_histogram_equalization.m │ ├── perform_image_resize.m │ ├── perform_tensor_recomp.m │ ├── perform_vf_normalization.m │ ├── plot_edges.m │ ├── plot_mesh.m │ ├── prod_vf_sf.m │ ├── progressbar.m │ ├── read_mesh.m │ ├── read_off.m │ ├── rescale.m │ └── triangulation2adjacency.m ├── toolbox_fast_marching.m └── vol3d.m ├── toolbox_graph ├── adjacency2incidence.m ├── adjmatrix2list.m ├── batch_levelsets_meshes.m ├── build_euclidean_weight_matrix.m ├── build_graph_from_image.m ├── bunny.gim.jpg ├── check_face_vertex.m ├── check_incircle.m ├── check_incircle_edge.m ├── compile_mex.m ├── compute_boundary.m ├── compute_combinatorial_laplacian.m ├── compute_curvature.m ├── compute_delaunay.m ├── compute_diffusion_geometry.m ├── compute_diffusion_kernel.m ├── compute_distance_graph.m ├── compute_dual_graph.m ├── compute_edge_face_ring.m ├── compute_edges.m ├── compute_face_ring.m ├── compute_geometric_laplacian.m ├── compute_laplacian_curve.m ├── compute_levelset_mesh.m ├── compute_mesh_gradient.m ├── compute_mesh_laplacian.m ├── compute_mesh_local_covariance.m ├── compute_mesh_weight.m ├── compute_normal.m ├── compute_orthocenter.m ├── compute_orthoproj_triangulation.m ├── compute_parameterization.m ├── compute_rotation.m ├── compute_semidual_graph.m ├── compute_traveling_salesman.m ├── compute_triangulation_angles.m ├── compute_vertex_face_ring.m ├── compute_vertex_ring.m ├── compute_voronoi_mesh.m ├── content.m ├── convert_gim2mesh.m ├── griddata_arbitrary.m ├── html │ ├── content.html │ ├── content.png │ ├── content_01.png │ ├── content_02.png │ ├── content_03.png │ ├── content_04.png │ ├── content_05.png │ ├── content_06.png │ ├── content_07.png │ ├── content_08.png │ ├── content_09.png │ ├── content_10.png │ ├── content_11.png │ ├── content_12.png │ ├── gpeyre.xsl │ └── style.css ├── incidence2adjacency.m ├── load_gim.m ├── load_graph.m ├── mesh.exe ├── mesh_flip_faces.m ├── mesh_previewer.m ├── mesh_wrapper.m ├── metro.exe ├── metro_wrapper.m ├── mex │ ├── config.h │ ├── dijkstra.cpp │ ├── fheap │ │ ├── fib.cpp │ │ ├── fib.h │ │ ├── fibpriv.h │ │ ├── fibtest.c │ │ ├── fibtest2.c │ │ ├── tt.c │ │ └── use.c │ ├── fibheap.h │ ├── perform_dijkstra_propagation.cpp │ ├── perform_dijkstra_propagation.def │ ├── perform_dijkstra_propagation.vcproj │ └── toolbox_graph.sln ├── off │ ├── beetle.off │ ├── cube.off │ ├── cube_oversampled.off │ ├── cylinder.off │ ├── elephant-50kv.off │ ├── hhh.off │ ├── hole_sphere1.off │ ├── hole_sphere2.off │ ├── hole_sphere3.off │ ├── hole_sphere4.off │ ├── hole_sphere5.off │ ├── hole_sphere6.off │ ├── hypersheet.off │ ├── mannequin.off │ ├── mushroom.off │ ├── nefertiti-entire.off │ ├── nefertiti.off │ ├── pipes.off │ ├── tre_twist.off │ └── venus.off ├── pawn.wrl ├── perform_delaunay_flipping.m ├── perform_dijkstra.m ├── perform_dijkstra_fast.dll ├── perform_dijkstra_fast.mexmaci ├── perform_dijkstra_path_extraction.m ├── perform_dijkstra_propagation.dll ├── perform_dijkstra_propagation.m ├── perform_dijkstra_propagation.mexglx ├── perform_dijkstra_propagation.mexmaci ├── perform_dijkstra_propagation_old.m ├── perform_dijkstra_propagation_slow.m ├── perform_faces_reorientation.m ├── perform_floyd_algorithm.m ├── perform_lloyd_iteration.m ├── perform_mesh_heat_diffusion.m ├── perform_mesh_simplification.m ├── perform_mesh_smoothing.m ├── perform_normal_displacement.m ├── perform_point_picking.m ├── perform_saturation.m ├── perform_triangle_flipping.m ├── plot_dijkstra.m ├── plot_edges.m ├── plot_geometry_image.m ├── plot_graph.m ├── plot_mesh.m ├── plot_silouhette.m ├── plot_spherical_triangulation.m ├── progressive_mesh.m ├── publish_html.m ├── qslim.m ├── read_gim.m ├── read_mesh.m ├── read_mfile.m ├── read_obj.m ├── read_off.m ├── read_ply.m ├── read_smf.m ├── read_tet.m ├── read_vtk.m ├── read_wrl.m ├── reverse_orientation.m ├── select3d.m ├── tests │ ├── test_compression.m │ ├── test_compression_fixed.m │ ├── test_constrained_delaunay.m │ ├── test_curvature.m │ ├── test_diffusion_wavelets.m │ ├── test_dijkstra.m │ ├── test_dijkstra_astar.m │ ├── test_drawing.m │ ├── test_duality.m │ ├── test_face_reorientation.m │ ├── test_filling_holes.m │ ├── test_flattening.m │ ├── test_free_boundary.m │ ├── test_grid_data.m │ ├── test_image_approx_refinement.m │ ├── test_image_approx_thining.m │ ├── test_laplacian_curve.m │ ├── test_levelset_mesh.m │ ├── test_lloyd.m │ ├── test_mesh.m │ ├── test_mesh_processing.m │ ├── test_mesh_simplification.m │ ├── test_mesh_smoothing.m │ ├── test_mex.m │ ├── test_parameterization.m │ ├── test_spectra.m │ ├── test_spherical_triangulation_drawing.m │ ├── test_tets.m │ └── test_wave_equation.m ├── tet2tri.m ├── toolbox │ ├── clamp.m │ ├── crop.m │ ├── getoptions.m │ ├── imageplot.m │ ├── isomap.m │ ├── load_curve.m │ ├── nb_dims.m │ ├── norme.m │ ├── perform_analysis_regularization.m │ ├── progressbar.m │ └── rescale.m ├── toolbox_graph.m ├── triangle.exe ├── triangulate.m ├── triangulation2adjacency.m ├── triangulation_isequal.m ├── write_gim.m ├── write_mesh.m ├── write_obj.m ├── write_off.m ├── write_ply.m ├── write_smf.m └── write_wrl.m ├── toolbox_image ├── apply_colormap.m ├── barb.png ├── callback_ti_wavelets.m ├── change_color_mode.m ├── compile_mex.m ├── compute_dead_leaves_image.m ├── compute_directional_kernel.m ├── compute_gabor_filter.m ├── compute_movie_file.m ├── compute_periodic_poisson.m ├── compute_random_patches.m ├── compute_ssim_index.m ├── compute_subwindows_energy.m ├── compute_subwindows_matrix.m ├── compute_texture_patchwork.m ├── compute_total_variation.m ├── content.m ├── display_image_layout.m ├── grab_inpainting_mask.m ├── html │ ├── content.html │ ├── content.png │ ├── content_01.png │ ├── content_02.png │ ├── content_03.png │ ├── content_04.png │ ├── content_05.png │ ├── content_06.png │ ├── content_07.png │ ├── content_08.png │ ├── content_09.png │ ├── content_10.png │ ├── content_11.png │ ├── content_12.png │ ├── gpeyre.xsl │ └── style.css ├── imageplot.m ├── imagesc_log.m ├── imagesc_std.m ├── lena.png ├── load_hdr.m ├── load_image.m ├── mex │ ├── config.h │ ├── perform_adaptive_filtering.cpp │ ├── perform_adaptive_filtering.def │ └── perform_adaptive_filtering.vcproj ├── perform_2d_int_translation.m ├── perform_adaptive_filtering.dll ├── perform_adaptive_filtering.mexglx ├── perform_adaptive_filtering.mexmaci ├── perform_bilateral_filtering.m ├── perform_blurring.m ├── perform_directional_filtering.m ├── perform_fast_rbf_interpolation.m ├── perform_image_extension.m ├── perform_image_resize.m ├── perform_image_rotation.m ├── perform_image_similitude.m ├── perform_lic.m ├── perform_local_dct_transform.m ├── perform_median_filtering.m ├── perform_quincunx_interpolation.m ├── perform_shape_smoothing.m ├── perform_tv_correction.m ├── perform_tv_hilbert_projection.m ├── perform_tv_projection.m ├── perform_varying_blurring.m ├── perform_windowed_dct4_transform.m ├── perform_windowed_dct_transform.m ├── perform_windowed_fourier_transform.m ├── perform_zooming.m ├── publish_html.m ├── read_lum.m ├── readme.txt ├── save_image.m ├── select_region.m ├── select_sub_image.m ├── symmetric_extension.m ├── tests │ ├── test_adaptive_filtering.m │ ├── test_analysis_regularization.m │ ├── test_bilateral.m │ ├── test_denoising_tv.m │ ├── test_directional_filtering.m │ ├── test_hdr_tonemapping.m │ ├── test_image_rotation.m │ ├── test_image_similitude.m │ ├── test_lic.m │ ├── test_local_dct.m │ ├── test_movie_making.m │ ├── test_periodic_laplacian.m │ ├── test_structure_texture_decomposition.m │ ├── test_svd_image.m │ ├── test_tv_projection.m │ └── test_windowed_fourier_transform.m ├── toolbox │ ├── callback_atrou.m │ ├── clamp.m │ ├── compute_gaussian_filter.m │ ├── compute_grad.m │ ├── compute_patch_library.m │ ├── compute_rigidity_tensor.m │ ├── compute_structure_tensor.m │ ├── crop.m │ ├── div.m │ ├── getoptions.m │ ├── grad.m │ ├── perform_convolution.m │ ├── perform_dct_transform.m │ ├── perform_histogram_equalization.m │ ├── perform_tensor_decomp.m │ ├── perform_tensor_recomp.m │ ├── perform_tv_denoising.m │ ├── perform_vf_integration.m │ ├── perform_vf_normalization.m │ ├── plot_tensor_field.m │ ├── prod_tf_sf.m │ ├── prod_tf_tf.m │ ├── prod_tf_vf.m │ ├── prod_vf_sf.m │ ├── prod_vf_vf.m │ ├── progressbar.m │ ├── psnr.m │ └── rescale.m └── write_lum.m ├── toolbox_misc ├── apply_tensorial.m ├── array_get_dimension.m ├── array_get_val.m ├── array_set_dimension.m ├── array_set_val.m ├── build_vandermonde_matrix.m ├── ccc.m ├── cell_add.m ├── clamp.m ├── compute_all_patch.m ├── compute_orthogonal_projection.m ├── compute_patch_library.m ├── compute_tensorial_operator.m ├── compute_zeros.m ├── copying ├── copyright ├── crossp.m ├── det3.m ├── dist_eucl.m ├── dist_sphere.m ├── dump_struct.m ├── eval_spline.m ├── extract_subsquares.m ├── get_color_from_index.m ├── getoptions.m ├── invmod.m ├── keep_above.m ├── keep_biggest.m ├── l2error.m ├── lexicmp.m ├── matrix_sampling_add.m ├── matrix_sampling_get.m ├── matrix_sampling_set.m ├── mmax.m ├── mmin.m ├── nb_dims.m ├── norme.m ├── num2string_fixeddigit.m ├── perform_square_extraction.m ├── play_movie.m ├── plot_circle.m ├── plot_scattered.m ├── poly_derivate.m ├── poly_root.m ├── poly_val.m ├── progressbar.m ├── remove_doublon.m ├── rescale.m ├── rev_sort_abs.m ├── reverse.m ├── reverse_permutation.m ├── set_thicklines.m ├── shuffle.m ├── toolbox_array.m ├── toolbox_misc.m └── verbose_output.m ├── toolbox_nlmeans ├── batch_denoising.m ├── batch_inpainting.m ├── batch_synthesis.m ├── compile_mex.m ├── compute_best_threshold_nlmeans.m ├── compute_edge_patches.m ├── html │ ├── gpeyre.xsl │ └── style.css ├── images │ ├── corral.png │ ├── deadleaf-masked.png │ ├── fabric-masked.png │ ├── grass-masked.png │ ├── group-people.jpg │ ├── hair-masked.png │ ├── lenacoul.jpg │ ├── olives.png │ └── reptilskin-masked.png ├── mex │ ├── config.h │ ├── perform_nlmeans_mex - copie.cpp │ └── perform_nlmeans_mex.cpp ├── perform_lowdim_embedding.m ├── perform_nl_means.m ├── perform_nlmeans_mex.mexmaci ├── perform_synthesis_quilting.m ├── publish_html.m ├── readme ├── tests │ ├── test_denoising.m │ ├── test_edge_synthesis.m │ ├── test_impulsive.m │ ├── test_nl_inpainting.m │ ├── test_nl_synthesis.m │ ├── test_nlmeans.m │ ├── test_nlmeans_duo.m │ └── test_patchwise.m └── toolbox │ ├── barb.png │ ├── clamp.m │ ├── compute_impulse_noise.m │ ├── compute_patch_library.m │ ├── crop.m │ ├── display_image_layout.m │ ├── getoptions.m │ ├── imnoise.m │ ├── load_image.m │ ├── num2string_fixeddigit.m │ ├── ordfilt2 │ ├── checkstrs.m │ ├── medfilt2.m │ ├── mex │ │ ├── ordf.c │ │ ├── ordf_hist.h │ │ ├── ordf_ordfilt2.h │ │ └── ordf_select.h │ ├── mkconstarray.m │ ├── ordf.mexmaci │ ├── ordfilt2.m │ └── padarray.m │ ├── pca.m │ ├── perform_blsgsm_denoising.m │ ├── perform_histogram_equalization.m │ ├── perform_image_resize.m │ ├── perform_median_filtering.m │ ├── perform_wavelet_matching.m │ ├── perform_wavelet_transform.m │ ├── progressbar.m │ ├── rescale.m │ ├── stabrnd.m │ └── symmetric_extension.m ├── toolbox_optim ├── .dropbox ├── Icon ├── compute_dual_prox.m ├── perform_dr.m ├── perform_dr_spingarn.m ├── perform_fb.m ├── perform_fb_strongly.m ├── perform_primal_dual.m ├── readme ├── tests │ ├── html │ │ ├── test_l1_constraint.html │ │ ├── test_l1_constraint.png │ │ ├── test_l1_constraint_01.png │ │ ├── test_l1_constraint_02.png │ │ ├── test_l1_lagrangian.html │ │ ├── test_l1_lagrangian.png │ │ ├── test_l1_lagrangian_01.png │ │ ├── test_tv_constraint.html │ │ ├── test_tv_constraint.png │ │ ├── test_tv_constraint_01.png │ │ ├── test_tv_lagrangian.html │ │ ├── test_tv_lagrangian.png │ │ ├── test_tv_lagrangian_01.png │ │ ├── test_tv_lagrangian_02.png │ │ └── test_tv_lagrangian_03.png │ ├── old │ │ └── test_fbstrongly_analysis.m │ ├── publish_all.m │ ├── test_DRAP.m │ ├── test_DRAP3D.m │ ├── test_auxvar.m │ ├── test_l1_constraint.m │ ├── test_l1_lagrangian.m │ ├── test_spingarn.m │ ├── test_tv_constraint.m │ ├── test_tv_lagrangian.m │ └── test_wl.m └── toolbox │ ├── apply_multiple_ouput.m │ ├── clamp.m │ ├── compute_correlation_error.m │ ├── compute_gaussian_filter.m │ ├── compute_operator_norm.m │ ├── crop.m │ ├── div.m │ ├── getoptions.m │ ├── grad.m │ ├── grad.sci │ ├── image_resize.m │ ├── imageplot.m │ ├── lena.png │ ├── load_image.m │ ├── perform_blurring.m │ ├── perform_convolution.m │ ├── perform_l1ball_projection.m │ ├── perform_simplex_projection.m │ ├── perform_simplex_projection_weighted.m │ ├── perform_soft_thresholding.m │ ├── perform_wavortho_transf.m │ ├── progressbar.m │ ├── rescale.m │ └── s2v.m ├── toolbox_signal ├── adjust_psnr.m ├── compile_mex.m ├── compute_conditional_histogram.m ├── compute_conv_matrix.m ├── compute_cubic_spline.m ├── compute_dct_matrix.m ├── compute_diffusion_distance.m ├── compute_distance_matrix.m ├── compute_distance_to_points.m ├── compute_entropy.m ├── compute_error_threshold.m ├── compute_gaussian_filter.m ├── compute_histogram.m ├── compute_histogram_distance.m ├── compute_histogram_rbf.m ├── compute_hufftree.m ├── compute_impulse_noise.m ├── compute_kurtosis.m ├── compute_laplacian_distribution.m ├── compute_laplacian_matrix.m ├── compute_mutual_information.m ├── compute_pairwise_histogram.m ├── compute_rbf.m ├── compute_skewness.m ├── compute_symmetric_conditional_histogram.m ├── crop.m ├── dirac.m ├── gen_brownian_motion.m ├── html │ ├── gpeyre.xsl │ └── style.css ├── load_signal.m ├── load_sound.m ├── mad.m ├── mex │ ├── Debug │ │ ├── Arith.obj │ │ ├── BitIO.obj │ │ ├── BuildLog.htm │ │ ├── IntCoding.obj │ │ ├── ac.obj │ │ ├── arcmak.obj │ │ ├── arcode.obj │ │ ├── arcsum.obj │ │ ├── coder.obj │ │ ├── entropy.obj │ │ ├── global.obj │ │ ├── iHisto.obj │ │ ├── nrutil.obj │ │ ├── perform_adaptive_filtering.obj │ │ ├── perform_arithmetic_coding_escape.obj │ │ ├── perform_arithmetic_coding_fixed.obj │ │ ├── perform_arithmetic_coding_mex.obj │ │ ├── vc70.idb │ │ └── vc70.pdb │ ├── ac.cpp │ ├── ac.h │ ├── coder │ │ ├── Arith.cpp │ │ ├── Arith.h │ │ ├── BitIO.cpp │ │ ├── BitIO.h │ │ ├── IntCoding.cpp │ │ ├── IntCoding.hh │ │ ├── Makefile │ │ ├── README │ │ ├── allocator.cc │ │ ├── allocator.hh │ │ ├── coder.cpp │ │ ├── coder.hh │ │ ├── coeffset.cc │ │ ├── coeffset.hh │ │ ├── compare.cc │ │ ├── decode.cc │ │ ├── encode.cc │ │ ├── entropy.cpp │ │ ├── entropy.hh │ │ ├── filter.cc │ │ ├── global.cpp │ │ ├── global.hh │ │ ├── iHisto.cpp │ │ ├── iHisto.h │ │ ├── image.cc │ │ ├── image.hh │ │ ├── images │ │ │ ├── barbara.pgm │ │ │ ├── goldhill.pgm │ │ │ └── lena512.pgm │ │ ├── metric.hh │ │ ├── pgm2raw.cc │ │ ├── quantizer.cc │ │ ├── quantizer.hh │ │ ├── raw2pgm.cc │ │ ├── transform.cc │ │ ├── transform.hh │ │ ├── wavelet.cc │ │ └── wavelet.hh │ ├── config.h │ ├── nr │ │ ├── arcmak.cpp │ │ ├── arcode.cpp │ │ ├── arcsum.cpp │ │ ├── nrutil.cpp │ │ └── nrutil.h │ ├── perform_arithmetic_coding_escape.cpp │ ├── perform_arithmetic_coding_escape.def │ ├── perform_arithmetic_coding_escape.vcproj │ ├── perform_arithmetic_coding_fixed.cpp │ ├── perform_arithmetic_coding_fixed.def │ ├── perform_arithmetic_coding_fixed.vcproj │ ├── perform_arithmetic_coding_mex.cpp │ ├── perform_arithmetic_coding_mex.def │ ├── perform_arithmetic_coding_mex.vcproj │ └── toolbox_signal.sln ├── perform_arithmetic_coding.m ├── perform_arithmetic_coding_fixed.dll ├── perform_arithmetic_coding_fixed.mexglx ├── perform_arithmetic_coding_mex.dll ├── perform_arithmetic_coding_mex.mexglx ├── perform_arithmetic_coding_mex.mexmaci ├── perform_best_dct.m ├── perform_chirpz_transform.m ├── perform_classical_mds.m ├── perform_conditional_histogram_matching.m ├── perform_convolution.m ├── perform_dct2_transform.m ├── perform_dct_transform.m ├── perform_histogram_equalization.m ├── perform_histogram_matching.m ├── perform_huffcoding.m ├── perform_kmeans.m ├── perform_laplacian_fitting.m ├── perform_moment_equalization.m ├── perform_noise_estimation.m ├── perform_quantization.m ├── perform_rbf_interpolation.m ├── perform_rle_coding.m ├── perform_shannon_estimation.m ├── perform_shannon_interpolation.m ├── perform_spectral_orthogonalization.m ├── perform_tensorial_transform.m ├── perform_thresholding.m ├── perform_vector_quantization.m ├── perform_walsh_transform.m ├── perform_wiener_filtering.m ├── plot_best_basis.m ├── plot_hufftree.m ├── psnr.m ├── publish_html.m ├── rand_discr.m ├── readme.txt ├── snr.m ├── tests │ ├── test_arithfixed.m │ ├── test_arithmetic_coder.m │ ├── test_convolution.m │ ├── test_filter.m │ ├── test_histo_equalization.m │ ├── test_histogram_interpolation.m │ ├── test_huffman.m │ ├── test_plot_dct.m │ ├── test_rbf_1d.m │ ├── test_rbf_2d.m │ ├── test_rle.m │ ├── test_vector_huff.m │ └── test_vq.m └── toolbox │ ├── array_set_val.m │ ├── barb.png │ ├── clamp.m │ ├── compute_grad.m │ ├── compute_rigidity_tensor.m │ ├── compute_structure_tensor.m │ ├── getoptions.m │ ├── imageplot.m │ ├── lena.png │ ├── load_image.m │ ├── perform_tensor_decomp.m │ ├── perform_tensor_recomp.m │ ├── perform_vf_normalization.m │ ├── plot_scattered.m │ ├── plot_tensor_field.m │ ├── prod_tf_sf.m │ ├── prod_tf_tf.m │ ├── prod_tf_vf.m │ ├── prod_vf_sf.m │ ├── prod_vf_vf.m │ └── rescale.m ├── toolbox_sparsity ├── callback_atrou.m ├── callback_blurring.m ├── callback_dct_wavelets.m ├── callback_dictionary.m ├── callback_doubleoperator.m ├── callback_fft.m ├── callback_identity.m ├── callback_inpainting.m ├── callback_localdct.m ├── callback_sensing_rand.m ├── callback_tomography.m ├── compile_mex.m ├── compute_coherenc.m ├── compute_coherence.m ├── compute_coherence_criterion.m ├── compute_compressed_sensing_matrix.m ├── compute_erc_criterion.m ├── compute_fuchs_criterion.m ├── compute_inpainting_mask.m ├── compute_minimum_scale.m ├── compute_rand_sparse.m ├── compute_recovery_rate.m ├── compute_redundant_dictionary.m ├── compute_sparse_spike_filter.m ├── compute_synthetic_dictionary.m ├── compute_tomography_mask.m ├── compute_werc_criterion.m ├── content.m ├── display_dictionnary.m ├── html │ ├── content.html │ ├── content.png │ ├── content_01.png │ ├── content_02.png │ ├── content_03.png │ ├── content_04.png │ ├── content_05.png │ ├── content_06.png │ ├── content_07.png │ ├── content_08.png │ ├── content_09.png │ ├── content_10.png │ ├── content_11.png │ ├── content_12.png │ ├── content_13.png │ ├── content_14.png │ ├── content_15.png │ ├── content_16.png │ ├── content_17.png │ ├── gpeyre.xsl │ └── style.css ├── load_random_patches.m ├── mex │ ├── config.h │ ├── defs_and_types.h │ ├── invert.c │ ├── invert.h │ ├── mat_omp.c │ ├── matrix_vector.c │ ├── matrix_vector.h │ └── perform_omp.c ├── perform_analysis_regularization.m ├── perform_bp_benchmark.m ├── perform_bregman_l1.m ├── perform_cs_matrix_optimization.m ├── perform_debiasing.m ├── perform_dictionary_learning.m ├── perform_dictionary_signature_learning.m ├── perform_douglas_rachford.m ├── perform_iterative_thresholding.m ├── perform_iterative_thresholding__old.m ├── perform_l1_recovery.m ├── perform_l1ball_projection.m ├── perform_linear_inpainting.m ├── perform_mca.m ├── perform_mp.m ├── perform_omp.m ├── perform_omp_mex.mexmaci ├── perform_orthogonal_learning_clustering.m ├── perform_tv_denoising.m ├── plot_sparse_diracs.m ├── publish_html.m ├── readme ├── tests │ ├── test_bp_omp.m │ ├── test_criterion.m │ ├── test_cs_conditionning.m │ ├── test_deconvolution.m │ ├── test_dictionary_learning.m │ ├── test_dictionary_signature.m │ ├── test_fuchs.m │ ├── test_iterative_thresholding.m │ ├── test_l1_recovery.m │ ├── test_learning_missing.m │ ├── test_mca_wavdct.m │ ├── test_omp.m │ ├── test_optimized_compressed_sensing.m │ ├── test_tv_algorithms.m │ └── test_tv_projection.m └── toolbox │ ├── SolveBP.m │ ├── SolveOMP.m │ ├── barb.png │ ├── c3wpt.dll │ ├── c3wpt.mexmaci │ ├── c3wpti.dll │ ├── c3wpti.mexmaci │ ├── cgsolve.m │ ├── clamp.m │ ├── compute_all_patch.m │ ├── compute_fourier_matrix.m │ ├── compute_gaussian_filter.m │ ├── compute_haar_matrix.m │ ├── compute_random_patches.m │ ├── compute_total_variation.m │ ├── crop.m │ ├── cwpt2.dll │ ├── cwpt2.mexmaci │ ├── cwpt2_btree.dll │ ├── cwpt2_btree.mexmaci │ ├── cwpt2_interface.m │ ├── cwpt2i.dll │ ├── cwpt2i.mexmaci │ ├── div.m │ ├── getoptions.m │ ├── grab_inpainting_mask.m │ ├── grad.m │ ├── imageplot.m │ ├── l1eq_pd.m │ ├── lena.png │ ├── load_image.m │ ├── mad.m │ ├── mdwt.dll │ ├── mdwt.mexmaci │ ├── midwt.dll │ ├── midwt.mexmaci │ ├── mirdwt.dll │ ├── mirdwt.mexmaci │ ├── mrdwt.dll │ ├── mrdwt.mexmaci │ ├── pdco.m │ ├── pdcoSet.m │ ├── perform_atrou_transform.m │ ├── perform_blurring.m │ ├── perform_conjugate_gradient.m │ ├── perform_convolution.m │ ├── perform_dct_transform.m │ ├── perform_thresholding.m │ ├── perform_tv_correction.m │ ├── perform_wavelet_transform.m │ ├── perform_windowed_dct_transform.m │ ├── perform_windowed_fourier_transform.m │ ├── progressbar.m │ ├── psnr.m │ └── rescale.m ├── toolbox_tensor_voting ├── compute_ball_tf.m ├── compute_stick_tf.m ├── perform_voting.m ├── perform_voting_ball.m ├── tests │ ├── test_ball.m │ └── test_structure.m ├── toolbox │ ├── compute_diff.m │ ├── compute_gaussian_filter.m │ ├── compute_grad.m │ ├── compute_hessian.m │ ├── compute_laplacian.m │ ├── compute_local_maxima.m │ ├── compute_operator_1.m │ ├── compute_operator_2.m │ ├── compute_rigidity_tensor.m │ ├── compute_vf_polar_dec.m │ ├── getoptions.m │ ├── main.m │ ├── perform_convolution.m │ ├── perform_curve_extraction.m │ ├── perform_tensor_decomp.m │ ├── perform_tensor_recomp.m │ ├── perform_vf_normalization.m │ ├── perform_vf_reorientation.m │ ├── plot_curve.m │ ├── plot_tf.m │ ├── plot_vf.m │ ├── plot_vf_scaterred.m │ ├── prod_tf_sf.m │ ├── prod_tf_tf.m │ ├── prod_tf_vf.m │ ├── prod_vf_sf.m │ ├── prod_vf_vf.m │ └── toolbox_diffc.m └── toolbox_tensor_voting.m ├── toolbox_wavelet_meshes ├── compute_base_mesh.m ├── compute_butterfly_neighbors.m ├── compute_semiregular_gim.m ├── compute_semiregular_sphere.m ├── content.m ├── data │ ├── earth-bw.jpg │ └── lena.png ├── gim │ ├── bunny-gim.gim │ └── bunny-sph.gim ├── html │ ├── content.html │ ├── content.png │ ├── content_01.png │ ├── content_02.png │ ├── content_03.png │ ├── content_04.png │ ├── content_05.png │ ├── content_06.png │ ├── content_07.png │ ├── gpeyre.xsl │ └── style.css ├── load_spherical_function.m ├── loop.m ├── perform_curve_subdivision.m ├── perform_haar_graph.m ├── perform_mesh_subdivision.m ├── perform_sgim_sampling.m ├── perform_spherial_planar_sampling.m ├── perform_wavelet_mesh_transform.m ├── plot_spherical_function.m ├── publish_html.m ├── readme.txt ├── tests │ ├── test_create_gim.m │ ├── test_semiregular_meshes.m │ ├── test_sphere.m │ ├── test_subdivision_curve.m │ ├── test_subdivision_mesh.m │ ├── test_subdivision_polyhedra.m │ └── test_wavelet_meshes.m └── toolbox │ ├── check_face_vertex.m │ ├── clamp.m │ ├── compute_edge_face_ring.m │ ├── compute_face_ring.m │ ├── compute_gaussian_filter.m │ ├── compute_mesh_weight.m │ ├── compute_normal.m │ ├── compute_vertex_face_ring.m │ ├── compute_vertex_ring.m │ ├── crop.m │ ├── getoptions.m │ ├── griddata_arbitrary.m │ ├── imageplot.m │ ├── keep_above.m │ ├── keep_biggest.m │ ├── load_gim.m │ ├── load_image.m │ ├── mannequin.off │ ├── perform_blurring.m │ ├── perform_convolution.m │ ├── perform_mesh_smoothing.m │ ├── plot_geometry_image.m │ ├── plot_mesh.m │ ├── progressbar.m │ ├── read_gim.m │ ├── read_mesh.m │ ├── read_off.m │ ├── rescale.m │ ├── triangulation2adjacency.m │ ├── venus.off │ └── write_gim.m └── toolbox_wavelets ├── c3wpt.dll ├── c3wpt.mexmaci ├── c3wpti.dll ├── c3wpti.mexmaci ├── compile_mex.m ├── compute_best_threshold.m ├── compute_gabor_features.m ├── compute_haar_matrix.m ├── compute_quadrant_selection.m ├── compute_spline_filter.m ├── content.m ├── convert_wavelet2vect.m ├── convert_wavelets2list.m ├── corrDn.mexmaci ├── cwpt2.dll ├── cwpt2.mexmaci ├── cwpt2_btree.dll ├── cwpt2_btree.mexmaci ├── cwpt2_interface.m ├── cwpt2i.dll ├── cwpt2i.mexmaci ├── histo.mexmaci ├── html ├── content.html ├── content.png ├── content_01.png ├── content_02.png ├── content_03.png ├── content_04.png ├── content_05.png ├── content_06.png ├── content_07.png ├── content_08.png ├── content_09.png ├── content_10.png ├── gpeyre.xsl └── style.css ├── image_to_j2k.exe ├── j2k_to_image.exe ├── jbgtopbm.exe ├── jbig1.dll ├── jp2_class.mexglx ├── jp2k ├── compile_jp2k.m ├── jp2_codec.m ├── jp2class_degrade.m ├── jp2codec_degrade.m └── perform_jp2_rescaling.m ├── lifting ├── get_lifting_param.m ├── perform_79_transform.dll ├── perform_79_transform.m ├── perform_79_transform.mexmaci ├── perform_79_transform_slow.m ├── perform_lifting_transform.dll ├── perform_lifting_transform.m ├── perform_lifting_transform.mexmaci ├── perform_lifting_transform_byname.m ├── perform_lifting_transform_slow.m ├── perform_wavelet_transform_hyperbolic.m ├── perform_wavelet_transform_isotropic.m └── readme ├── mdwt.dll ├── mdwt.mexmaci ├── mex ├── config.h ├── perform_79_transform.cpp ├── perform_79_transform.def ├── perform_79_transform.h ├── perform_79_transform.vcproj ├── perform_haar_transform.cpp ├── perform_haar_transform.def ├── perform_haar_transform.h ├── perform_haar_transform.vcproj ├── perform_lifting_transform.cpp ├── perform_lifting_transform.def ├── perform_lifting_transform.h ├── perform_lifting_transform.vcproj ├── simoncelli │ ├── convolve.c │ ├── convolve.h │ ├── corrDn.c │ ├── edges-orig.c │ ├── edges.c │ ├── histo.c │ ├── innerProd.c │ ├── pointOp.c │ ├── range2.c │ ├── upConv.c │ └── wrap.c └── toolbox_wavelets.sln ├── midwt.dll ├── midwt.mexmaci ├── mirdwt.dll ├── mirdwt.mexmaci ├── mrdwt.dll ├── mrdwt.mexmaci ├── pbmtojbg.exe ├── perform_atrou_transform.m ├── perform_blsgsm_denoising.m ├── perform_circle_haar_transform.m ├── perform_cpx_dualtree_transform.m ├── perform_curvelet_transform.m ├── perform_haar_transform.dll ├── perform_haar_transform.m ├── perform_haar_transform.mexmaci ├── perform_haar_transform_1d.m ├── perform_haar_transform_slow.m ├── perform_histogram_matching_wavelet.m ├── perform_jbig_coding.m ├── perform_jp2k_compression.m ├── perform_jp2k_degradation.m ├── perform_jp2k_encoding.dll ├── perform_jp2k_encoding.mexmaci ├── perform_lifting_transform.m ├── perform_pyramid_transform.m ├── perform_pyramid_transform_nonframe.m ├── perform_pyramid_transform_simoncelli.m ├── perform_pyramid_transform_ti.m ├── perform_quicunx_wavelet_transform_ti.m ├── perform_quincunx_wavelet_transform.m ├── perform_real_dualtree_transform.m ├── perform_segmentation.m ├── perform_segmentation_colorization.m ├── perform_shannon_estimation_wavelets.m ├── perform_spaciowav_matching.m ├── perform_spiht_coding.m ├── perform_steerable_matching.m ├── perform_steerable_transform.m ├── perform_waveatoms_transform.m ├── perform_wavelet_arithmetic_coding.m ├── perform_wavelet_jp2k_coding.m ├── perform_wavelet_matching.m ├── perform_wavelet_transform.m ├── perform_wavelet_transform_irregular.m ├── plot_quincunx_wavelet.m ├── plot_wavelet.m ├── pointOp.mexmaci ├── publish_html.m ├── range2.mexmaci ├── readme ├── reorder_coefs.m ├── tests ├── den2d_block.m ├── test_atrou.m ├── test_block_thresholding.m ├── test_circle_haar.m ├── test_classical.m ├── test_compression.m ├── test_denoising.m ├── test_denoising_blsgsm.m ├── test_dualtree.m ├── test_haar_transform_1d.m ├── test_j2k.m ├── test_laplacian_arithmetic_coding.m ├── test_laplacian_do.m ├── test_laplacian_pyramid.m ├── test_lifting.m ├── test_lifting_irregular.m ├── test_mex.m ├── test_openjpeg.m ├── test_pyramidal.m ├── test_quincunx.m ├── test_quincunx_ti.m ├── test_reorder_coefs.m ├── test_segmentation_gabor.m ├── test_statistics.m ├── test_statistics_batch.m ├── test_steerable.m ├── test_texture_synthesis_wavelets.m ├── test_wavelet.m └── test_wavelets_ti.m ├── toolbox ├── apply_tensorial.m ├── clamp.m ├── compute_symmetric_conditional_histogram.m ├── crop.m ├── getoptions.m ├── hair.png ├── histo.m ├── imageplot.m ├── keep_biggest.m ├── lena.png ├── load_image.m ├── load_signal.m ├── perform_histogram_equalization.m ├── perform_image_extension.m ├── perform_quantization.m ├── perform_thresholding.m ├── psnr.m └── rescale.m ├── upConv.dll └── upConv.mexmaci /toolbox_alpert/build_alpert_matrix_1d.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/build_alpert_matrix_1d.m -------------------------------------------------------------------------------- /toolbox_alpert/build_alpert_matrix_2d.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/build_alpert_matrix_2d.m -------------------------------------------------------------------------------- /toolbox_alpert/compile_mex.m: -------------------------------------------------------------------------------- 1 | % compile mex file 2 | mex mex/perform_moment_transform.cpp mex/perform_moment_transform_mex.cpp -------------------------------------------------------------------------------- /toolbox_alpert/dichotomic_grouping.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/dichotomic_grouping.m -------------------------------------------------------------------------------- /toolbox_alpert/html/content.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/html/content.png -------------------------------------------------------------------------------- /toolbox_alpert/html/content_01.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/html/content_01.png -------------------------------------------------------------------------------- /toolbox_alpert/html/content_02.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/html/content_02.png -------------------------------------------------------------------------------- /toolbox_alpert/html/content_03.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/html/content_03.png -------------------------------------------------------------------------------- /toolbox_alpert/html/content_04.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/html/content_04.png -------------------------------------------------------------------------------- /toolbox_alpert/html/content_05.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/html/content_05.png -------------------------------------------------------------------------------- /toolbox_alpert/html/content_06.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/html/content_06.png -------------------------------------------------------------------------------- /toolbox_alpert/html/content_07.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/html/content_07.png -------------------------------------------------------------------------------- /toolbox_alpert/mex/config.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/mex/config.h -------------------------------------------------------------------------------- /toolbox_alpert/mex/perform_moment_transform.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/mex/perform_moment_transform.cpp -------------------------------------------------------------------------------- /toolbox_alpert/mex/perform_moment_transform.def: -------------------------------------------------------------------------------- 1 | LIBRARY perform_moment_transform.dll 2 | EXPORTS 3 | mexFunction 4 | -------------------------------------------------------------------------------- /toolbox_alpert/perform_alpert_transform_1d.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/perform_alpert_transform_1d.m -------------------------------------------------------------------------------- /toolbox_alpert/perform_alpert_transform_2d.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/perform_alpert_transform_2d.m -------------------------------------------------------------------------------- /toolbox_alpert/perform_alpert_transform_2d_sliced.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/perform_alpert_transform_2d_sliced.m -------------------------------------------------------------------------------- /toolbox_alpert/perform_alpert_transform_nd.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/perform_alpert_transform_nd.m -------------------------------------------------------------------------------- /toolbox_alpert/perform_moment_transform.dll: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/perform_moment_transform.dll -------------------------------------------------------------------------------- /toolbox_alpert/perform_moment_transform_slow.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/perform_moment_transform_slow.m -------------------------------------------------------------------------------- /toolbox_alpert/plot_dichotomic_partition.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/plot_dichotomic_partition.m -------------------------------------------------------------------------------- /toolbox_alpert/plot_spherical_function.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/plot_spherical_function.m -------------------------------------------------------------------------------- /toolbox_alpert/plot_spherical_partition.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/plot_spherical_partition.m -------------------------------------------------------------------------------- /toolbox_alpert/tests/test_decreasing_1d.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/tests/test_decreasing_1d.m -------------------------------------------------------------------------------- /toolbox_alpert/tests/test_decreasing_2d.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/tests/test_decreasing_2d.m -------------------------------------------------------------------------------- /toolbox_alpert/tests/test_decreasing_nd.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/tests/test_decreasing_nd.m -------------------------------------------------------------------------------- /toolbox_alpert/tests/test_grouping.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/tests/test_grouping.m -------------------------------------------------------------------------------- /toolbox_alpert/tests/test_mex.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/tests/test_mex.m -------------------------------------------------------------------------------- /toolbox_alpert/tests/test_plot_1d.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/tests/test_plot_1d.m -------------------------------------------------------------------------------- /toolbox_alpert/tests/test_plot_2d.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/tests/test_plot_2d.m -------------------------------------------------------------------------------- /toolbox_alpert/tests/test_speed_2d.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/tests/test_speed_2d.m -------------------------------------------------------------------------------- /toolbox_alpert/toolbox/array_get_val.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/toolbox/array_get_val.m -------------------------------------------------------------------------------- /toolbox_alpert/toolbox/array_set_val.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/toolbox/array_set_val.m -------------------------------------------------------------------------------- /toolbox_alpert/toolbox/clamp.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/toolbox/clamp.m -------------------------------------------------------------------------------- /toolbox_alpert/toolbox/compute_distance_to_points.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/toolbox/compute_distance_to_points.m -------------------------------------------------------------------------------- /toolbox_alpert/toolbox/dirac.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/toolbox/dirac.m -------------------------------------------------------------------------------- /toolbox_alpert/toolbox/gen_base_mesh.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/toolbox/gen_base_mesh.m -------------------------------------------------------------------------------- /toolbox_alpert/toolbox/gen_signal.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/toolbox/gen_signal.m -------------------------------------------------------------------------------- /toolbox_alpert/toolbox/gen_signal_2d.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/toolbox/gen_signal_2d.m -------------------------------------------------------------------------------- /toolbox_alpert/toolbox/get_color_from_index.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/toolbox/get_color_from_index.m -------------------------------------------------------------------------------- /toolbox_alpert/toolbox/imageplot.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/toolbox/imageplot.m -------------------------------------------------------------------------------- /toolbox_alpert/toolbox/keep_biggest.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/toolbox/keep_biggest.m -------------------------------------------------------------------------------- /toolbox_alpert/toolbox/l2error.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/toolbox/l2error.m -------------------------------------------------------------------------------- /toolbox_alpert/toolbox/lena.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/toolbox/lena.png -------------------------------------------------------------------------------- /toolbox_alpert/toolbox/mmax.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/toolbox/mmax.m -------------------------------------------------------------------------------- /toolbox_alpert/toolbox/mmin.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/toolbox/mmin.m -------------------------------------------------------------------------------- /toolbox_alpert/toolbox/norme.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/toolbox/norme.m -------------------------------------------------------------------------------- /toolbox_alpert/toolbox/plot_scattered.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/toolbox/plot_scattered.m -------------------------------------------------------------------------------- /toolbox_alpert/toolbox/plot_wavelet.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/toolbox/plot_wavelet.m -------------------------------------------------------------------------------- /toolbox_alpert/toolbox/rev_sort_abs.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/toolbox/rev_sort_abs.m -------------------------------------------------------------------------------- /toolbox_alpert/toolbox/reverse_permutation.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/toolbox/reverse_permutation.m -------------------------------------------------------------------------------- /toolbox_alpert/toolbox/subdivide_sphere.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_alpert/toolbox/subdivide_sphere.m -------------------------------------------------------------------------------- /toolbox_curve/compute_bezier_curve.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_curve/compute_bezier_curve.m -------------------------------------------------------------------------------- /toolbox_curve/compute_cuvilinear_abscice.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_curve/compute_cuvilinear_abscice.m -------------------------------------------------------------------------------- /toolbox_curve/compute_hausdorff_distance.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_curve/compute_hausdorff_distance.m -------------------------------------------------------------------------------- /toolbox_curve/gen_levy_flight.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_curve/gen_levy_flight.m -------------------------------------------------------------------------------- /toolbox_curve/gen_rand_curve.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_curve/gen_rand_curve.m -------------------------------------------------------------------------------- /toolbox_curve/hilbert_curve.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_curve/hilbert_curve.m -------------------------------------------------------------------------------- /toolbox_curve/integrate_along_curve.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_curve/integrate_along_curve.m -------------------------------------------------------------------------------- /toolbox_curve/load_curve.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_curve/load_curve.m -------------------------------------------------------------------------------- /toolbox_curve/meshless_curve_reconstruction.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_curve/meshless_curve_reconstruction.m -------------------------------------------------------------------------------- /toolbox_curve/peano_curve.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_curve/peano_curve.m -------------------------------------------------------------------------------- /toolbox_curve/perform_contour_extraction.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_curve/perform_contour_extraction.m -------------------------------------------------------------------------------- /toolbox_curve/perform_curve_extraction.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_curve/perform_curve_extraction.m -------------------------------------------------------------------------------- /toolbox_curve/perform_curve_resampling.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_curve/perform_curve_resampling.m -------------------------------------------------------------------------------- /toolbox_curve/perform_curve_warping.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_curve/perform_curve_warping.m -------------------------------------------------------------------------------- /toolbox_curve/perform_normal_curve_transform.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_curve/perform_normal_curve_transform.m -------------------------------------------------------------------------------- /toolbox_curve/plot_curve.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_curve/plot_curve.m -------------------------------------------------------------------------------- /toolbox_curve/split_curve.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_curve/split_curve.m -------------------------------------------------------------------------------- /toolbox_curve/toolbox/keep_biggest.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_curve/toolbox/keep_biggest.m -------------------------------------------------------------------------------- /toolbox_diffc/compute_diff.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_diffc/compute_diff.m -------------------------------------------------------------------------------- /toolbox_diffc/compute_flow.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_diffc/compute_flow.m -------------------------------------------------------------------------------- /toolbox_diffc/compute_grad.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_diffc/compute_grad.m -------------------------------------------------------------------------------- /toolbox_diffc/compute_laplacian.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_diffc/compute_laplacian.m -------------------------------------------------------------------------------- /toolbox_diffc/compute_local_maxima.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_diffc/compute_local_maxima.m -------------------------------------------------------------------------------- /toolbox_diffc/compute_operator_1.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_diffc/compute_operator_1.m -------------------------------------------------------------------------------- /toolbox_diffc/compute_operator_2.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_diffc/compute_operator_2.m -------------------------------------------------------------------------------- /toolbox_diffc/compute_vf_polar_dec.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_diffc/compute_vf_polar_dec.m -------------------------------------------------------------------------------- /toolbox_diffc/data/sparse-curve.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_diffc/data/sparse-curve.png -------------------------------------------------------------------------------- /toolbox_diffc/html/content.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_diffc/html/content.png -------------------------------------------------------------------------------- /toolbox_diffc/html/content_01.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_diffc/html/content_01.png -------------------------------------------------------------------------------- /toolbox_diffc/html/content_02.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_diffc/html/content_02.png -------------------------------------------------------------------------------- /toolbox_diffc/html/content_03.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_diffc/html/content_03.png -------------------------------------------------------------------------------- /toolbox_diffc/html/content_04.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_diffc/html/content_04.png -------------------------------------------------------------------------------- /toolbox_diffc/html/content_05.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_diffc/html/content_05.png -------------------------------------------------------------------------------- /toolbox_diffc/load_flow.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_diffc/load_flow.m -------------------------------------------------------------------------------- /toolbox_diffc/perform_orientation_diffusion.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_diffc/perform_orientation_diffusion.m -------------------------------------------------------------------------------- /toolbox_diffc/perform_tensor_decomp.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_diffc/perform_tensor_decomp.m -------------------------------------------------------------------------------- /toolbox_diffc/perform_tensor_recomp.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_diffc/perform_tensor_recomp.m -------------------------------------------------------------------------------- /toolbox_diffc/plot_vf_scaterred.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_diffc/plot_vf_scaterred.m -------------------------------------------------------------------------------- /toolbox_diffc/prod_tf_sf.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_diffc/prod_tf_sf.m -------------------------------------------------------------------------------- /toolbox_diffc/prod_tf_vf.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_diffc/prod_tf_vf.m -------------------------------------------------------------------------------- /toolbox_diffc/prod_vf_sf.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_diffc/prod_vf_sf.m -------------------------------------------------------------------------------- /toolbox_diffc/prod_vf_vf.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_diffc/prod_vf_vf.m -------------------------------------------------------------------------------- /toolbox_diffc/tests/test_diffc.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_diffc/tests/test_diffc.m -------------------------------------------------------------------------------- /toolbox_diffc/toolbox/clamp.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_diffc/toolbox/clamp.m -------------------------------------------------------------------------------- /toolbox_diffc/toolbox/compute_gaussian_filter.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_diffc/toolbox/compute_gaussian_filter.m -------------------------------------------------------------------------------- /toolbox_diffc/toolbox/lena.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_diffc/toolbox/lena.png -------------------------------------------------------------------------------- /toolbox_diffc/toolbox/nb_dims.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_diffc/toolbox/nb_dims.m -------------------------------------------------------------------------------- /toolbox_diffc/toolbox_diffc.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_diffc/toolbox_diffc.m -------------------------------------------------------------------------------- /toolbox_dimreduc/addchv.dll: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_dimreduc/addchv.dll -------------------------------------------------------------------------------- /toolbox_dimreduc/addchv.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_dimreduc/addchv.mexmaci -------------------------------------------------------------------------------- /toolbox_dimreduc/compute_nn_graph.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_dimreduc/compute_nn_graph.m -------------------------------------------------------------------------------- /toolbox_dimreduc/corrsum.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_dimreduc/corrsum.mexmaci -------------------------------------------------------------------------------- /toolbox_dimreduc/corrsum2.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_dimreduc/corrsum2.mexmaci -------------------------------------------------------------------------------- /toolbox_dimreduc/data/frey_rawface.mat: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_dimreduc/data/frey_rawface.mat -------------------------------------------------------------------------------- /toolbox_dimreduc/dijkstra_fast.dll: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_dimreduc/dijkstra_fast.dll -------------------------------------------------------------------------------- /toolbox_dimreduc/emb_brute_nn.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_dimreduc/emb_brute_nn.mexmaci -------------------------------------------------------------------------------- /toolbox_dimreduc/leigs.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_dimreduc/leigs.m -------------------------------------------------------------------------------- /toolbox_dimreduc/lle.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_dimreduc/lle.m -------------------------------------------------------------------------------- /toolbox_dimreduc/load_images_dataset.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_dimreduc/load_images_dataset.m -------------------------------------------------------------------------------- /toolbox_dimreduc/load_points_set.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_dimreduc/load_points_set.m -------------------------------------------------------------------------------- /toolbox_dimreduc/load_subimages_dataset.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_dimreduc/load_subimages_dataset.m -------------------------------------------------------------------------------- /toolbox_dimreduc/nn_brute.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_dimreduc/nn_brute.mexmaci -------------------------------------------------------------------------------- /toolbox_dimreduc/nn_prepare.dll: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_dimreduc/nn_prepare.dll -------------------------------------------------------------------------------- /toolbox_dimreduc/nn_prepare.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_dimreduc/nn_prepare.mexmaci -------------------------------------------------------------------------------- /toolbox_dimreduc/nn_search.dll: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_dimreduc/nn_search.dll -------------------------------------------------------------------------------- /toolbox_dimreduc/nn_search.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_dimreduc/nn_search.mexmaci -------------------------------------------------------------------------------- /toolbox_dimreduc/pca.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_dimreduc/pca.m -------------------------------------------------------------------------------- /toolbox_dimreduc/perform_diffusion_mapping.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_dimreduc/perform_diffusion_mapping.m -------------------------------------------------------------------------------- /toolbox_dimreduc/perform_geodesic_embedding.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_dimreduc/perform_geodesic_embedding.m -------------------------------------------------------------------------------- /toolbox_dimreduc/perform_local_pca.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_dimreduc/perform_local_pca.m -------------------------------------------------------------------------------- /toolbox_dimreduc/plot_flattened_dataset.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_dimreduc/plot_flattened_dataset.m -------------------------------------------------------------------------------- /toolbox_dimreduc/range_brute.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_dimreduc/range_brute.mexmaci -------------------------------------------------------------------------------- /toolbox_dimreduc/range_search.dll: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_dimreduc/range_search.dll -------------------------------------------------------------------------------- /toolbox_dimreduc/range_search.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_dimreduc/range_search.mexmaci -------------------------------------------------------------------------------- /toolbox_dimreduc/readme: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_dimreduc/readme -------------------------------------------------------------------------------- /toolbox_dimreduc/tests/test_dimreduc.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_dimreduc/tests/test_dimreduc.m -------------------------------------------------------------------------------- /toolbox_dimreduc/tests/test_isomap_landmarks.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_dimreduc/tests/test_isomap_landmarks.m -------------------------------------------------------------------------------- /toolbox_dimreduc/tests/test_meshes.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_dimreduc/tests/test_meshes.m -------------------------------------------------------------------------------- /toolbox_dimreduc/tests/test_subimages.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_dimreduc/tests/test_subimages.m -------------------------------------------------------------------------------- /toolbox_dimreduc/toolbox/compute_distance_matrix.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_dimreduc/toolbox/compute_distance_matrix.m -------------------------------------------------------------------------------- /toolbox_dimreduc/toolbox/load_image.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_dimreduc/toolbox/load_image.m -------------------------------------------------------------------------------- /toolbox_dimreduc/toolbox/mmax.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_dimreduc/toolbox/mmax.m -------------------------------------------------------------------------------- /toolbox_dimreduc/toolbox/plot_graph.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_dimreduc/toolbox/plot_graph.m -------------------------------------------------------------------------------- /toolbox_dimreduc/toolbox/plot_mesh.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_dimreduc/toolbox/plot_mesh.m -------------------------------------------------------------------------------- /toolbox_dimreduc/toolbox/plot_scattered.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_dimreduc/toolbox/plot_scattered.m -------------------------------------------------------------------------------- /toolbox_dimreduc/toolbox/read_off.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_dimreduc/toolbox/read_off.m -------------------------------------------------------------------------------- /toolbox_dimreduc/toolbox/rescale.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_dimreduc/toolbox/rescale.m -------------------------------------------------------------------------------- /toolbox_dimreduc/toolbox/test_rbf.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_dimreduc/toolbox/test_rbf.m -------------------------------------------------------------------------------- /toolbox_dimreduc/toolbox/triangulation2adjacency.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_dimreduc/toolbox/triangulation2adjacency.m -------------------------------------------------------------------------------- /toolbox_fast_marching/batch_shape_meshing.m: -------------------------------------------------------------------------------- 1 | for use_adaptive=0:1 2 | for p = [200 400 1000] 3 | test_shape_meshing; 4 | end 5 | end -------------------------------------------------------------------------------- /toolbox_fast_marching/compute_distance_landmark.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/compute_distance_landmark.m -------------------------------------------------------------------------------- /toolbox_fast_marching/compute_edge_energy.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/compute_edge_energy.m -------------------------------------------------------------------------------- /toolbox_fast_marching/compute_geodesic.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/compute_geodesic.m -------------------------------------------------------------------------------- /toolbox_fast_marching/compute_heuristic_landmark.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/compute_heuristic_landmark.m -------------------------------------------------------------------------------- /toolbox_fast_marching/data/apple.gif: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/data/apple.gif -------------------------------------------------------------------------------- /toolbox_fast_marching/data/brain.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/data/brain.png -------------------------------------------------------------------------------- /toolbox_fast_marching/data/camel.gif: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/data/camel.gif -------------------------------------------------------------------------------- /toolbox_fast_marching/data/cavern.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/data/cavern.png -------------------------------------------------------------------------------- /toolbox_fast_marching/data/chan-vese.jpg: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/data/chan-vese.jpg -------------------------------------------------------------------------------- /toolbox_fast_marching/data/chicken.gif: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/data/chicken.gif -------------------------------------------------------------------------------- /toolbox_fast_marching/data/giraffe.gif: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/data/giraffe.gif -------------------------------------------------------------------------------- /toolbox_fast_marching/data/image01.tiff: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/data/image01.tiff -------------------------------------------------------------------------------- /toolbox_fast_marching/data/mm.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/data/mm.png -------------------------------------------------------------------------------- /toolbox_fast_marching/data/mountain.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/data/mountain.png -------------------------------------------------------------------------------- /toolbox_fast_marching/data/road2.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/data/road2.png -------------------------------------------------------------------------------- /toolbox_fast_marching/data/room.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/data/room.png -------------------------------------------------------------------------------- /toolbox_fast_marching/data/room1.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/data/room1.png -------------------------------------------------------------------------------- /toolbox_fast_marching/display_eccentricity.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/display_eccentricity.m -------------------------------------------------------------------------------- /toolbox_fast_marching/eucdist2.dll: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/eucdist2.dll -------------------------------------------------------------------------------- /toolbox_fast_marching/eucdist2.mexglx: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/eucdist2.mexglx -------------------------------------------------------------------------------- /toolbox_fast_marching/eucdist2.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/eucdist2.mexmaci -------------------------------------------------------------------------------- /toolbox_fast_marching/fm2dAniso.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/fm2dAniso.mexmaci -------------------------------------------------------------------------------- /toolbox_fast_marching/generate_constrained_map.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/generate_constrained_map.m -------------------------------------------------------------------------------- /toolbox_fast_marching/html/content.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/html/content.png -------------------------------------------------------------------------------- /toolbox_fast_marching/html/content_01.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/html/content_01.png -------------------------------------------------------------------------------- /toolbox_fast_marching/html/content_02.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/html/content_02.png -------------------------------------------------------------------------------- /toolbox_fast_marching/html/content_03.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/html/content_03.png -------------------------------------------------------------------------------- /toolbox_fast_marching/html/content_04.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/html/content_04.png -------------------------------------------------------------------------------- /toolbox_fast_marching/html/content_05.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/html/content_05.png -------------------------------------------------------------------------------- /toolbox_fast_marching/html/content_06.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/html/content_06.png -------------------------------------------------------------------------------- /toolbox_fast_marching/html/content_07.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/html/content_07.png -------------------------------------------------------------------------------- /toolbox_fast_marching/html/content_08.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/html/content_08.png -------------------------------------------------------------------------------- /toolbox_fast_marching/html/content_09.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/html/content_09.png -------------------------------------------------------------------------------- /toolbox_fast_marching/html/content_10.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/html/content_10.png -------------------------------------------------------------------------------- /toolbox_fast_marching/html/content_11.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/html/content_11.png -------------------------------------------------------------------------------- /toolbox_fast_marching/load_potential_map.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/load_potential_map.m -------------------------------------------------------------------------------- /toolbox_fast_marching/mex/config.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/mex/config.h -------------------------------------------------------------------------------- /toolbox_fast_marching/mex/gw/gw.suo: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/mex/gw/gw.suo -------------------------------------------------------------------------------- /toolbox_fast_marching/mex/gw/gw_core/GW_Config.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/mex/gw/gw_core/GW_Config.cpp -------------------------------------------------------------------------------- /toolbox_fast_marching/mex/gw/gw_core/GW_Config.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/mex/gw/gw_core/GW_Config.h -------------------------------------------------------------------------------- /toolbox_fast_marching/mex/gw/gw_core/GW_Face.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/mex/gw/gw_core/GW_Face.cpp -------------------------------------------------------------------------------- /toolbox_fast_marching/mex/gw/gw_core/GW_Face.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/mex/gw/gw_core/GW_Face.h -------------------------------------------------------------------------------- /toolbox_fast_marching/mex/gw/gw_core/GW_Face.inl: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/mex/gw/gw_core/GW_Face.inl -------------------------------------------------------------------------------- /toolbox_fast_marching/mex/gw/gw_core/GW_Mesh.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/mex/gw/gw_core/GW_Mesh.cpp -------------------------------------------------------------------------------- /toolbox_fast_marching/mex/gw/gw_core/GW_Mesh.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/mex/gw/gw_core/GW_Mesh.h -------------------------------------------------------------------------------- /toolbox_fast_marching/mex/gw/gw_core/GW_Mesh.inl: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/mex/gw/gw_core/GW_Mesh.inl -------------------------------------------------------------------------------- /toolbox_fast_marching/mex/gw/gw_core/GW_Vertex.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/mex/gw/gw_core/GW_Vertex.cpp -------------------------------------------------------------------------------- /toolbox_fast_marching/mex/gw/gw_core/GW_Vertex.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/mex/gw/gw_core/GW_Vertex.h -------------------------------------------------------------------------------- /toolbox_fast_marching/mex/gw/gw_core/GW_Vertex.inl: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/mex/gw/gw_core/GW_Vertex.inl -------------------------------------------------------------------------------- /toolbox_fast_marching/mex/gw/gw_core/stdafx.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/mex/gw/gw_core/stdafx.h -------------------------------------------------------------------------------- /toolbox_fast_marching/mex/gw/gw_geodesic/GW_TriangularInterpolation.cpp: -------------------------------------------------------------------------------- 1 | #error removed -------------------------------------------------------------------------------- /toolbox_fast_marching/mex/gw/gw_geodesic/GW_TriangularInterpolation.h: -------------------------------------------------------------------------------- 1 | #error removed -------------------------------------------------------------------------------- /toolbox_fast_marching/mex/gw/gw_geodesic/GW_TriangularInterpolation.inl: -------------------------------------------------------------------------------- 1 | #error removed -------------------------------------------------------------------------------- /toolbox_fast_marching/mex/gw/gw_geodesic/stdafx.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/mex/gw/gw_geodesic/stdafx.h -------------------------------------------------------------------------------- /toolbox_fast_marching/mex/gw/gw_maths/GW_Maths.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/mex/gw/gw_maths/GW_Maths.h -------------------------------------------------------------------------------- /toolbox_fast_marching/mex/gw/gw_maths/GW_Vector2D.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/mex/gw/gw_maths/GW_Vector2D.h -------------------------------------------------------------------------------- /toolbox_fast_marching/mex/gw/gw_maths/GW_Vector3D.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/mex/gw/gw_maths/GW_Vector3D.h -------------------------------------------------------------------------------- /toolbox_fast_marching/mex/gw/gw_maths/GW_Vector4D.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/mex/gw/gw_maths/GW_Vector4D.h -------------------------------------------------------------------------------- /toolbox_fast_marching/mex/gw/gw_maths/GW_VectorND.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/mex/gw/gw_maths/GW_VectorND.h -------------------------------------------------------------------------------- /toolbox_fast_marching/mex/gw/gw_maths/gw_complex.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/mex/gw/gw_maths/gw_complex.h -------------------------------------------------------------------------------- /toolbox_fast_marching/mex/gw/gw_toolkit/stdafx.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/mex/gw/gw_toolkit/stdafx.h -------------------------------------------------------------------------------- /toolbox_fast_marching/mex/perform_circular_front_propagation_2d.def: -------------------------------------------------------------------------------- 1 | LIBRARY perform_circular_front_propagation_2d.dll 2 | EXPORTS 3 | mexFunction -------------------------------------------------------------------------------- /toolbox_fast_marching/mex/perform_front_propagation_2d.def: -------------------------------------------------------------------------------- 1 | LIBRARY perform_front_propagation_2d.dll 2 | EXPORTS 3 | mexFunction -------------------------------------------------------------------------------- /toolbox_fast_marching/mex/perform_front_propagation_3d.def: -------------------------------------------------------------------------------- 1 | LIBRARY perform_front_propagation_3d.dll 2 | EXPORTS 3 | mexFunction -------------------------------------------------------------------------------- /toolbox_fast_marching/mex/perform_front_propagation_mesh.def: -------------------------------------------------------------------------------- 1 | LIBRARY perform_front_propagation_mesh.dll 2 | EXPORTS 3 | mexFunction -------------------------------------------------------------------------------- /toolbox_fast_marching/perform_fmstar_2d.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/perform_fmstar_2d.m -------------------------------------------------------------------------------- /toolbox_fast_marching/perform_fmstar_3d.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/perform_fmstar_3d.m -------------------------------------------------------------------------------- /toolbox_fast_marching/pick_start_end_point.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/pick_start_end_point.m -------------------------------------------------------------------------------- /toolbox_fast_marching/plot_fast_marching_2d.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/plot_fast_marching_2d.m -------------------------------------------------------------------------------- /toolbox_fast_marching/plot_fast_marching_3d.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/plot_fast_marching_3d.m -------------------------------------------------------------------------------- /toolbox_fast_marching/plot_volumetric_data.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/plot_volumetric_data.m -------------------------------------------------------------------------------- /toolbox_fast_marching/skeleton.dll: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/skeleton.dll -------------------------------------------------------------------------------- /toolbox_fast_marching/skeleton.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/skeleton.mexmaci -------------------------------------------------------------------------------- /toolbox_fast_marching/tests/test_circular.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/tests/test_circular.m -------------------------------------------------------------------------------- /toolbox_fast_marching/tests/test_circular_prior.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/tests/test_circular_prior.m -------------------------------------------------------------------------------- /toolbox_fast_marching/tests/test_eucldist.m: -------------------------------------------------------------------------------- 1 | % test for euclidean distance 2 | 3 | M = load_image('disk', 128); 4 | M = logical(M); 5 | [D,L] = eucdist2(M); -------------------------------------------------------------------------------- /toolbox_fast_marching/tests/test_fast_marching_2d.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/tests/test_fast_marching_2d.m -------------------------------------------------------------------------------- /toolbox_fast_marching/tests/test_fast_marching_3d.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/tests/test_fast_marching_3d.m -------------------------------------------------------------------------------- /toolbox_fast_marching/tests/test_fmstar_2d.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/tests/test_fmstar_2d.m -------------------------------------------------------------------------------- /toolbox_fast_marching/tests/test_fmstar_3d.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/tests/test_fmstar_3d.m -------------------------------------------------------------------------------- /toolbox_fast_marching/tests/test_fmstar_error.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/tests/test_fmstar_error.m -------------------------------------------------------------------------------- /toolbox_fast_marching/tests/test_fmstar_landmark.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/tests/test_fmstar_landmark.m -------------------------------------------------------------------------------- /toolbox_fast_marching/tests/test_fmstar_weight_2d.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/tests/test_fmstar_weight_2d.m -------------------------------------------------------------------------------- /toolbox_fast_marching/tests/test_segmentation.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/tests/test_segmentation.m -------------------------------------------------------------------------------- /toolbox_fast_marching/toolbox/clamp.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/toolbox/clamp.m -------------------------------------------------------------------------------- /toolbox_fast_marching/toolbox/compute_edges.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/toolbox/compute_edges.m -------------------------------------------------------------------------------- /toolbox_fast_marching/toolbox/compute_grad.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/toolbox/compute_grad.m -------------------------------------------------------------------------------- /toolbox_fast_marching/toolbox/compute_vertex_ring.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/toolbox/compute_vertex_ring.m -------------------------------------------------------------------------------- /toolbox_fast_marching/toolbox/imageplot.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/toolbox/imageplot.m -------------------------------------------------------------------------------- /toolbox_fast_marching/toolbox/mmax.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/toolbox/mmax.m -------------------------------------------------------------------------------- /toolbox_fast_marching/toolbox/nb_dims.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/toolbox/nb_dims.m -------------------------------------------------------------------------------- /toolbox_fast_marching/toolbox/perform_convolution.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/toolbox/perform_convolution.m -------------------------------------------------------------------------------- /toolbox_fast_marching/toolbox/plot_edges.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/toolbox/plot_edges.m -------------------------------------------------------------------------------- /toolbox_fast_marching/toolbox/plot_mesh.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/toolbox/plot_mesh.m -------------------------------------------------------------------------------- /toolbox_fast_marching/toolbox/prod_vf_sf.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/toolbox/prod_vf_sf.m -------------------------------------------------------------------------------- /toolbox_fast_marching/toolbox/progressbar.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/toolbox/progressbar.m -------------------------------------------------------------------------------- /toolbox_fast_marching/toolbox/read_off.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/toolbox/read_off.m -------------------------------------------------------------------------------- /toolbox_fast_marching/toolbox_fast_marching.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_fast_marching/toolbox_fast_marching.m -------------------------------------------------------------------------------- /toolbox_graph/adjmatrix2list.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/adjmatrix2list.m -------------------------------------------------------------------------------- /toolbox_graph/build_graph_from_image.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/build_graph_from_image.m -------------------------------------------------------------------------------- /toolbox_graph/bunny.gim.jpg: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/bunny.gim.jpg -------------------------------------------------------------------------------- /toolbox_graph/compile_mex.m: -------------------------------------------------------------------------------- 1 | % compile mex file for dijkstra 2 | 3 | mex mex/perform_dijkstra_propagation.cpp mex/fheap/fib.cpp 4 | mex mex/dijkstra.cpp -o perform_dijkstra_fast -------------------------------------------------------------------------------- /toolbox_graph/compute_curvature.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/compute_curvature.m -------------------------------------------------------------------------------- /toolbox_graph/compute_diffusion_geometry.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/compute_diffusion_geometry.m -------------------------------------------------------------------------------- /toolbox_graph/compute_diffusion_kernel.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/compute_diffusion_kernel.m -------------------------------------------------------------------------------- /toolbox_graph/compute_dual_graph.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/compute_dual_graph.m -------------------------------------------------------------------------------- /toolbox_graph/compute_edges.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/compute_edges.m -------------------------------------------------------------------------------- /toolbox_graph/compute_laplacian_curve.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/compute_laplacian_curve.m -------------------------------------------------------------------------------- /toolbox_graph/compute_normal.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/compute_normal.m -------------------------------------------------------------------------------- /toolbox_graph/compute_rotation.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/compute_rotation.m -------------------------------------------------------------------------------- /toolbox_graph/compute_semidual_graph.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/compute_semidual_graph.m -------------------------------------------------------------------------------- /toolbox_graph/compute_traveling_salesman.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/compute_traveling_salesman.m -------------------------------------------------------------------------------- /toolbox_graph/compute_vertex_ring.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/compute_vertex_ring.m -------------------------------------------------------------------------------- /toolbox_graph/convert_gim2mesh.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/convert_gim2mesh.m -------------------------------------------------------------------------------- /toolbox_graph/griddata_arbitrary.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/griddata_arbitrary.m -------------------------------------------------------------------------------- /toolbox_graph/html/content.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/html/content.png -------------------------------------------------------------------------------- /toolbox_graph/html/content_01.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/html/content_01.png -------------------------------------------------------------------------------- /toolbox_graph/html/content_02.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/html/content_02.png -------------------------------------------------------------------------------- /toolbox_graph/html/content_03.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/html/content_03.png -------------------------------------------------------------------------------- /toolbox_graph/html/content_04.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/html/content_04.png -------------------------------------------------------------------------------- /toolbox_graph/html/content_05.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/html/content_05.png -------------------------------------------------------------------------------- /toolbox_graph/html/content_06.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/html/content_06.png -------------------------------------------------------------------------------- /toolbox_graph/html/content_07.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/html/content_07.png -------------------------------------------------------------------------------- /toolbox_graph/html/content_08.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/html/content_08.png -------------------------------------------------------------------------------- /toolbox_graph/html/content_09.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/html/content_09.png -------------------------------------------------------------------------------- /toolbox_graph/html/content_10.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/html/content_10.png -------------------------------------------------------------------------------- /toolbox_graph/html/content_11.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/html/content_11.png -------------------------------------------------------------------------------- /toolbox_graph/html/content_12.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/html/content_12.png -------------------------------------------------------------------------------- /toolbox_graph/incidence2adjacency.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/incidence2adjacency.m -------------------------------------------------------------------------------- /toolbox_graph/load_graph.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/load_graph.m -------------------------------------------------------------------------------- /toolbox_graph/mesh.exe: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/mesh.exe -------------------------------------------------------------------------------- /toolbox_graph/mesh_previewer.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/mesh_previewer.m -------------------------------------------------------------------------------- /toolbox_graph/mesh_wrapper.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/mesh_wrapper.m -------------------------------------------------------------------------------- /toolbox_graph/metro.exe: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/metro.exe -------------------------------------------------------------------------------- /toolbox_graph/metro_wrapper.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/metro_wrapper.m -------------------------------------------------------------------------------- /toolbox_graph/mex/config.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/mex/config.h -------------------------------------------------------------------------------- /toolbox_graph/mex/perform_dijkstra_propagation.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/mex/perform_dijkstra_propagation.cpp -------------------------------------------------------------------------------- /toolbox_graph/mex/perform_dijkstra_propagation.def: -------------------------------------------------------------------------------- 1 | LIBRARY perform_dijkstra_propagation.dll 2 | EXPORTS 3 | mexFunction -------------------------------------------------------------------------------- /toolbox_graph/perform_dijkstra_fast.dll: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/perform_dijkstra_fast.dll -------------------------------------------------------------------------------- /toolbox_graph/perform_dijkstra_fast.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/perform_dijkstra_fast.mexmaci -------------------------------------------------------------------------------- /toolbox_graph/perform_dijkstra_path_extraction.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/perform_dijkstra_path_extraction.m -------------------------------------------------------------------------------- /toolbox_graph/perform_dijkstra_propagation.dll: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/perform_dijkstra_propagation.dll -------------------------------------------------------------------------------- /toolbox_graph/perform_dijkstra_propagation.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/perform_dijkstra_propagation.m -------------------------------------------------------------------------------- /toolbox_graph/perform_dijkstra_propagation.mexglx: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/perform_dijkstra_propagation.mexglx -------------------------------------------------------------------------------- /toolbox_graph/perform_dijkstra_propagation.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/perform_dijkstra_propagation.mexmaci -------------------------------------------------------------------------------- /toolbox_graph/perform_dijkstra_propagation_slow.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/perform_dijkstra_propagation_slow.m -------------------------------------------------------------------------------- /toolbox_graph/perform_floyd_algorithm.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/perform_floyd_algorithm.m -------------------------------------------------------------------------------- /toolbox_graph/perform_lloyd_iteration.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/perform_lloyd_iteration.m -------------------------------------------------------------------------------- /toolbox_graph/perform_mesh_simplification.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/perform_mesh_simplification.m -------------------------------------------------------------------------------- /toolbox_graph/plot_dijkstra.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/plot_dijkstra.m -------------------------------------------------------------------------------- /toolbox_graph/plot_edges.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/plot_edges.m -------------------------------------------------------------------------------- /toolbox_graph/plot_geometry_image.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/plot_geometry_image.m -------------------------------------------------------------------------------- /toolbox_graph/plot_mesh.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/plot_mesh.m -------------------------------------------------------------------------------- /toolbox_graph/read_gim.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/read_gim.m -------------------------------------------------------------------------------- /toolbox_graph/read_off.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/read_off.m -------------------------------------------------------------------------------- /toolbox_graph/read_ply.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/read_ply.m -------------------------------------------------------------------------------- /toolbox_graph/read_smf.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/read_smf.m -------------------------------------------------------------------------------- /toolbox_graph/read_wrl.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/read_wrl.m -------------------------------------------------------------------------------- /toolbox_graph/reverse_orientation.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/reverse_orientation.m -------------------------------------------------------------------------------- /toolbox_graph/tests/test_compression.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/tests/test_compression.m -------------------------------------------------------------------------------- /toolbox_graph/tests/test_compression_fixed.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/tests/test_compression_fixed.m -------------------------------------------------------------------------------- /toolbox_graph/tests/test_diffusion_wavelets.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/tests/test_diffusion_wavelets.m -------------------------------------------------------------------------------- /toolbox_graph/tests/test_flattening.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/tests/test_flattening.m -------------------------------------------------------------------------------- /toolbox_graph/tests/test_mex.m: -------------------------------------------------------------------------------- 1 | % test for mex file 2 | 3 | test_read_vrml = 1; 4 | 5 | if test_read_vrml 6 | filename = 'pawn.wrl'; 7 | [vertex,face] = read_vrml(filename); 8 | end -------------------------------------------------------------------------------- /toolbox_graph/tests/test_spectra.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/tests/test_spectra.m -------------------------------------------------------------------------------- /toolbox_graph/toolbox/clamp.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/toolbox/clamp.m -------------------------------------------------------------------------------- /toolbox_graph/toolbox/load_curve.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/toolbox/load_curve.m -------------------------------------------------------------------------------- /toolbox_graph/toolbox/nb_dims.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/toolbox/nb_dims.m -------------------------------------------------------------------------------- /toolbox_graph/toolbox/norme.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/toolbox/norme.m -------------------------------------------------------------------------------- /toolbox_graph/toolbox/progressbar.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/toolbox/progressbar.m -------------------------------------------------------------------------------- /toolbox_graph/toolbox/rescale.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/toolbox/rescale.m -------------------------------------------------------------------------------- /toolbox_graph/toolbox_graph.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/toolbox_graph.m -------------------------------------------------------------------------------- /toolbox_graph/triangle.exe: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/triangle.exe -------------------------------------------------------------------------------- /toolbox_graph/triangulate.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/triangulate.m -------------------------------------------------------------------------------- /toolbox_graph/triangulation2adjacency.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/triangulation2adjacency.m -------------------------------------------------------------------------------- /toolbox_graph/write_gim.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/write_gim.m -------------------------------------------------------------------------------- /toolbox_graph/write_mesh.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/write_mesh.m -------------------------------------------------------------------------------- /toolbox_graph/write_obj.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/write_obj.m -------------------------------------------------------------------------------- /toolbox_graph/write_off.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/write_off.m -------------------------------------------------------------------------------- /toolbox_graph/write_ply.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/write_ply.m -------------------------------------------------------------------------------- /toolbox_graph/write_smf.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/write_smf.m -------------------------------------------------------------------------------- /toolbox_graph/write_wrl.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_graph/write_wrl.m -------------------------------------------------------------------------------- /toolbox_image/barb.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/barb.png -------------------------------------------------------------------------------- /toolbox_image/compile_mex.m: -------------------------------------------------------------------------------- 1 | clear all; 2 | fprintf('Compiling mex files ... '); 3 | 4 | % compile mex files 5 | mex mex/perform_adaptive_filtering.cpp 6 | 7 | disp('done.'); -------------------------------------------------------------------------------- /toolbox_image/compute_dead_leaves_image.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/compute_dead_leaves_image.m -------------------------------------------------------------------------------- /toolbox_image/compute_directional_kernel.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/compute_directional_kernel.m -------------------------------------------------------------------------------- /toolbox_image/compute_random_patches.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/compute_random_patches.m -------------------------------------------------------------------------------- /toolbox_image/compute_subwindows_energy.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/compute_subwindows_energy.m -------------------------------------------------------------------------------- /toolbox_image/compute_subwindows_matrix.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/compute_subwindows_matrix.m -------------------------------------------------------------------------------- /toolbox_image/html/content.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/html/content.png -------------------------------------------------------------------------------- /toolbox_image/html/content_01.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/html/content_01.png -------------------------------------------------------------------------------- /toolbox_image/html/content_02.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/html/content_02.png -------------------------------------------------------------------------------- /toolbox_image/html/content_03.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/html/content_03.png -------------------------------------------------------------------------------- /toolbox_image/html/content_04.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/html/content_04.png -------------------------------------------------------------------------------- /toolbox_image/html/content_05.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/html/content_05.png -------------------------------------------------------------------------------- /toolbox_image/html/content_06.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/html/content_06.png -------------------------------------------------------------------------------- /toolbox_image/html/content_07.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/html/content_07.png -------------------------------------------------------------------------------- /toolbox_image/html/content_08.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/html/content_08.png -------------------------------------------------------------------------------- /toolbox_image/html/content_09.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/html/content_09.png -------------------------------------------------------------------------------- /toolbox_image/html/content_10.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/html/content_10.png -------------------------------------------------------------------------------- /toolbox_image/html/content_11.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/html/content_11.png -------------------------------------------------------------------------------- /toolbox_image/html/content_12.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/html/content_12.png -------------------------------------------------------------------------------- /toolbox_image/imageplot.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/imageplot.m -------------------------------------------------------------------------------- /toolbox_image/imagesc_std.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/imagesc_std.m -------------------------------------------------------------------------------- /toolbox_image/lena.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/lena.png -------------------------------------------------------------------------------- /toolbox_image/mex/config.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/mex/config.h -------------------------------------------------------------------------------- /toolbox_image/mex/perform_adaptive_filtering.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/mex/perform_adaptive_filtering.cpp -------------------------------------------------------------------------------- /toolbox_image/mex/perform_adaptive_filtering.def: -------------------------------------------------------------------------------- 1 | LIBRARY perform_adaptive_filtering.dll 2 | EXPORTS 3 | mexFunction -------------------------------------------------------------------------------- /toolbox_image/perform_2d_int_translation.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/perform_2d_int_translation.m -------------------------------------------------------------------------------- /toolbox_image/perform_adaptive_filtering.dll: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/perform_adaptive_filtering.dll -------------------------------------------------------------------------------- /toolbox_image/perform_adaptive_filtering.mexglx: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/perform_adaptive_filtering.mexglx -------------------------------------------------------------------------------- /toolbox_image/perform_adaptive_filtering.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/perform_adaptive_filtering.mexmaci -------------------------------------------------------------------------------- /toolbox_image/perform_directional_filtering.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/perform_directional_filtering.m -------------------------------------------------------------------------------- /toolbox_image/perform_fast_rbf_interpolation.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/perform_fast_rbf_interpolation.m -------------------------------------------------------------------------------- /toolbox_image/perform_image_similitude.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/perform_image_similitude.m -------------------------------------------------------------------------------- /toolbox_image/perform_shape_smoothing.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/perform_shape_smoothing.m -------------------------------------------------------------------------------- /toolbox_image/perform_tv_projection.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/perform_tv_projection.m -------------------------------------------------------------------------------- /toolbox_image/read_lum.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/read_lum.m -------------------------------------------------------------------------------- /toolbox_image/select_region.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/select_region.m -------------------------------------------------------------------------------- /toolbox_image/select_sub_image.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/select_sub_image.m -------------------------------------------------------------------------------- /toolbox_image/symmetric_extension.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/symmetric_extension.m -------------------------------------------------------------------------------- /toolbox_image/toolbox/clamp.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/toolbox/clamp.m -------------------------------------------------------------------------------- /toolbox_image/toolbox/compute_gaussian_filter.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/toolbox/compute_gaussian_filter.m -------------------------------------------------------------------------------- /toolbox_image/toolbox/compute_grad.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/toolbox/compute_grad.m -------------------------------------------------------------------------------- /toolbox_image/toolbox/compute_patch_library.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/toolbox/compute_patch_library.m -------------------------------------------------------------------------------- /toolbox_image/toolbox/compute_rigidity_tensor.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/toolbox/compute_rigidity_tensor.m -------------------------------------------------------------------------------- /toolbox_image/toolbox/compute_structure_tensor.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/toolbox/compute_structure_tensor.m -------------------------------------------------------------------------------- /toolbox_image/toolbox/perform_tensor_decomp.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/toolbox/perform_tensor_decomp.m -------------------------------------------------------------------------------- /toolbox_image/toolbox/perform_tensor_recomp.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/toolbox/perform_tensor_recomp.m -------------------------------------------------------------------------------- /toolbox_image/toolbox/perform_tv_denoising.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/toolbox/perform_tv_denoising.m -------------------------------------------------------------------------------- /toolbox_image/toolbox/perform_vf_normalization.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/toolbox/perform_vf_normalization.m -------------------------------------------------------------------------------- /toolbox_image/toolbox/plot_tensor_field.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/toolbox/plot_tensor_field.m -------------------------------------------------------------------------------- /toolbox_image/toolbox/prod_tf_sf.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/toolbox/prod_tf_sf.m -------------------------------------------------------------------------------- /toolbox_image/toolbox/prod_tf_tf.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/toolbox/prod_tf_tf.m -------------------------------------------------------------------------------- /toolbox_image/toolbox/prod_tf_vf.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/toolbox/prod_tf_vf.m -------------------------------------------------------------------------------- /toolbox_image/toolbox/prod_vf_sf.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/toolbox/prod_vf_sf.m -------------------------------------------------------------------------------- /toolbox_image/toolbox/prod_vf_vf.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/toolbox/prod_vf_vf.m -------------------------------------------------------------------------------- /toolbox_image/toolbox/progressbar.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/toolbox/progressbar.m -------------------------------------------------------------------------------- /toolbox_image/toolbox/psnr.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/toolbox/psnr.m -------------------------------------------------------------------------------- /toolbox_image/write_lum.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_image/write_lum.m -------------------------------------------------------------------------------- /toolbox_misc/apply_tensorial.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_misc/apply_tensorial.m -------------------------------------------------------------------------------- /toolbox_misc/array_get_dimension.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_misc/array_get_dimension.m -------------------------------------------------------------------------------- /toolbox_misc/array_get_val.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_misc/array_get_val.m -------------------------------------------------------------------------------- /toolbox_misc/array_set_dimension.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_misc/array_set_dimension.m -------------------------------------------------------------------------------- /toolbox_misc/array_set_val.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_misc/array_set_val.m -------------------------------------------------------------------------------- /toolbox_misc/build_vandermonde_matrix.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_misc/build_vandermonde_matrix.m -------------------------------------------------------------------------------- /toolbox_misc/ccc.m: -------------------------------------------------------------------------------- 1 | % ccc - clear all and clc; 2 | 3 | close all; clear all; clc; -------------------------------------------------------------------------------- /toolbox_misc/clamp.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_misc/clamp.m -------------------------------------------------------------------------------- /toolbox_misc/compute_patch_library.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_misc/compute_patch_library.m -------------------------------------------------------------------------------- /toolbox_misc/compute_tensorial_operator.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_misc/compute_tensorial_operator.m -------------------------------------------------------------------------------- /toolbox_misc/dist_eucl.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_misc/dist_eucl.m -------------------------------------------------------------------------------- /toolbox_misc/dist_sphere.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_misc/dist_sphere.m -------------------------------------------------------------------------------- /toolbox_misc/eval_spline.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_misc/eval_spline.m -------------------------------------------------------------------------------- /toolbox_misc/extract_subsquares.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_misc/extract_subsquares.m -------------------------------------------------------------------------------- /toolbox_misc/get_color_from_index.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_misc/get_color_from_index.m -------------------------------------------------------------------------------- /toolbox_misc/invmod.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_misc/invmod.m -------------------------------------------------------------------------------- /toolbox_misc/keep_above.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_misc/keep_above.m -------------------------------------------------------------------------------- /toolbox_misc/keep_biggest.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_misc/keep_biggest.m -------------------------------------------------------------------------------- /toolbox_misc/l2error.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_misc/l2error.m -------------------------------------------------------------------------------- /toolbox_misc/matrix_sampling_add.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_misc/matrix_sampling_add.m -------------------------------------------------------------------------------- /toolbox_misc/matrix_sampling_get.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_misc/matrix_sampling_get.m -------------------------------------------------------------------------------- /toolbox_misc/matrix_sampling_set.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_misc/matrix_sampling_set.m -------------------------------------------------------------------------------- /toolbox_misc/mmax.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_misc/mmax.m -------------------------------------------------------------------------------- /toolbox_misc/mmin.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_misc/mmin.m -------------------------------------------------------------------------------- /toolbox_misc/nb_dims.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_misc/nb_dims.m -------------------------------------------------------------------------------- /toolbox_misc/norme.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_misc/norme.m -------------------------------------------------------------------------------- /toolbox_misc/num2string_fixeddigit.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_misc/num2string_fixeddigit.m -------------------------------------------------------------------------------- /toolbox_misc/perform_square_extraction.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_misc/perform_square_extraction.m -------------------------------------------------------------------------------- /toolbox_misc/play_movie.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_misc/play_movie.m -------------------------------------------------------------------------------- /toolbox_misc/plot_scattered.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_misc/plot_scattered.m -------------------------------------------------------------------------------- /toolbox_misc/poly_derivate.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_misc/poly_derivate.m -------------------------------------------------------------------------------- /toolbox_misc/poly_root.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_misc/poly_root.m -------------------------------------------------------------------------------- /toolbox_misc/poly_val.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_misc/poly_val.m -------------------------------------------------------------------------------- /toolbox_misc/remove_doublon.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_misc/remove_doublon.m -------------------------------------------------------------------------------- /toolbox_misc/rev_sort_abs.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_misc/rev_sort_abs.m -------------------------------------------------------------------------------- /toolbox_misc/reverse.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_misc/reverse.m -------------------------------------------------------------------------------- /toolbox_misc/reverse_permutation.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_misc/reverse_permutation.m -------------------------------------------------------------------------------- /toolbox_misc/shuffle.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_misc/shuffle.m -------------------------------------------------------------------------------- /toolbox_misc/toolbox_array.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_misc/toolbox_array.m -------------------------------------------------------------------------------- /toolbox_misc/toolbox_misc.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_misc/toolbox_misc.m -------------------------------------------------------------------------------- /toolbox_misc/verbose_output.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_misc/verbose_output.m -------------------------------------------------------------------------------- /toolbox_nlmeans/images/corral.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_nlmeans/images/corral.png -------------------------------------------------------------------------------- /toolbox_nlmeans/images/deadleaf-masked.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_nlmeans/images/deadleaf-masked.png -------------------------------------------------------------------------------- /toolbox_nlmeans/images/fabric-masked.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_nlmeans/images/fabric-masked.png -------------------------------------------------------------------------------- /toolbox_nlmeans/images/grass-masked.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_nlmeans/images/grass-masked.png -------------------------------------------------------------------------------- /toolbox_nlmeans/images/group-people.jpg: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_nlmeans/images/group-people.jpg -------------------------------------------------------------------------------- /toolbox_nlmeans/images/hair-masked.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_nlmeans/images/hair-masked.png -------------------------------------------------------------------------------- /toolbox_nlmeans/images/lenacoul.jpg: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_nlmeans/images/lenacoul.jpg -------------------------------------------------------------------------------- /toolbox_nlmeans/images/olives.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_nlmeans/images/olives.png -------------------------------------------------------------------------------- /toolbox_nlmeans/images/reptilskin-masked.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_nlmeans/images/reptilskin-masked.png -------------------------------------------------------------------------------- /toolbox_nlmeans/mex/config.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_nlmeans/mex/config.h -------------------------------------------------------------------------------- /toolbox_nlmeans/mex/perform_nlmeans_mex - copie.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_nlmeans/mex/perform_nlmeans_mex - copie.cpp -------------------------------------------------------------------------------- /toolbox_nlmeans/mex/perform_nlmeans_mex.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_nlmeans/mex/perform_nlmeans_mex.cpp -------------------------------------------------------------------------------- /toolbox_nlmeans/perform_nlmeans_mex.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_nlmeans/perform_nlmeans_mex.mexmaci -------------------------------------------------------------------------------- /toolbox_nlmeans/readme: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_nlmeans/readme -------------------------------------------------------------------------------- /toolbox_nlmeans/toolbox/barb.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_nlmeans/toolbox/barb.png -------------------------------------------------------------------------------- /toolbox_nlmeans/toolbox/clamp.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_nlmeans/toolbox/clamp.m -------------------------------------------------------------------------------- /toolbox_nlmeans/toolbox/compute_patch_library.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_nlmeans/toolbox/compute_patch_library.m -------------------------------------------------------------------------------- /toolbox_nlmeans/toolbox/imnoise.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_nlmeans/toolbox/imnoise.m -------------------------------------------------------------------------------- /toolbox_nlmeans/toolbox/num2string_fixeddigit.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_nlmeans/toolbox/num2string_fixeddigit.m -------------------------------------------------------------------------------- /toolbox_nlmeans/toolbox/ordfilt2/ordf.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_nlmeans/toolbox/ordfilt2/ordf.mexmaci -------------------------------------------------------------------------------- /toolbox_nlmeans/toolbox/pca.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_nlmeans/toolbox/pca.m -------------------------------------------------------------------------------- /toolbox_nlmeans/toolbox/perform_image_resize.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_nlmeans/toolbox/perform_image_resize.m -------------------------------------------------------------------------------- /toolbox_nlmeans/toolbox/progressbar.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_nlmeans/toolbox/progressbar.m -------------------------------------------------------------------------------- /toolbox_nlmeans/toolbox/symmetric_extension.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_nlmeans/toolbox/symmetric_extension.m -------------------------------------------------------------------------------- /toolbox_optim/.dropbox: -------------------------------------------------------------------------------- 1 | 27524373 2 | -------------------------------------------------------------------------------- /toolbox_optim/Icon : -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_optim/Icon -------------------------------------------------------------------------------- /toolbox_optim/readme: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_optim/readme -------------------------------------------------------------------------------- /toolbox_optim/tests/html/test_l1_constraint.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_optim/tests/html/test_l1_constraint.png -------------------------------------------------------------------------------- /toolbox_optim/tests/html/test_l1_constraint_01.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_optim/tests/html/test_l1_constraint_01.png -------------------------------------------------------------------------------- /toolbox_optim/tests/html/test_l1_constraint_02.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_optim/tests/html/test_l1_constraint_02.png -------------------------------------------------------------------------------- /toolbox_optim/tests/html/test_l1_lagrangian.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_optim/tests/html/test_l1_lagrangian.png -------------------------------------------------------------------------------- /toolbox_optim/tests/html/test_l1_lagrangian_01.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_optim/tests/html/test_l1_lagrangian_01.png -------------------------------------------------------------------------------- /toolbox_optim/tests/html/test_tv_constraint.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_optim/tests/html/test_tv_constraint.png -------------------------------------------------------------------------------- /toolbox_optim/tests/html/test_tv_constraint_01.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_optim/tests/html/test_tv_constraint_01.png -------------------------------------------------------------------------------- /toolbox_optim/tests/html/test_tv_lagrangian.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_optim/tests/html/test_tv_lagrangian.png -------------------------------------------------------------------------------- /toolbox_optim/tests/html/test_tv_lagrangian_01.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_optim/tests/html/test_tv_lagrangian_01.png -------------------------------------------------------------------------------- /toolbox_optim/tests/html/test_tv_lagrangian_02.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_optim/tests/html/test_tv_lagrangian_02.png -------------------------------------------------------------------------------- /toolbox_optim/tests/html/test_tv_lagrangian_03.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_optim/tests/html/test_tv_lagrangian_03.png -------------------------------------------------------------------------------- /toolbox_optim/tests/test_auxvar.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_optim/tests/test_auxvar.m -------------------------------------------------------------------------------- /toolbox_optim/toolbox/clamp.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_optim/toolbox/clamp.m -------------------------------------------------------------------------------- /toolbox_optim/toolbox/compute_gaussian_filter.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_optim/toolbox/compute_gaussian_filter.m -------------------------------------------------------------------------------- /toolbox_optim/toolbox/lena.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_optim/toolbox/lena.png -------------------------------------------------------------------------------- /toolbox_optim/toolbox/perform_l1ball_projection.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_optim/toolbox/perform_l1ball_projection.m -------------------------------------------------------------------------------- /toolbox_optim/toolbox/progressbar.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_optim/toolbox/progressbar.m -------------------------------------------------------------------------------- /toolbox_signal/compute_conv_matrix.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/compute_conv_matrix.m -------------------------------------------------------------------------------- /toolbox_signal/compute_cubic_spline.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/compute_cubic_spline.m -------------------------------------------------------------------------------- /toolbox_signal/compute_dct_matrix.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/compute_dct_matrix.m -------------------------------------------------------------------------------- /toolbox_signal/compute_diffusion_distance.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/compute_diffusion_distance.m -------------------------------------------------------------------------------- /toolbox_signal/compute_distance_to_points.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/compute_distance_to_points.m -------------------------------------------------------------------------------- /toolbox_signal/compute_entropy.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/compute_entropy.m -------------------------------------------------------------------------------- /toolbox_signal/compute_error_threshold.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/compute_error_threshold.m -------------------------------------------------------------------------------- /toolbox_signal/compute_gaussian_filter.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/compute_gaussian_filter.m -------------------------------------------------------------------------------- /toolbox_signal/compute_histogram.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/compute_histogram.m -------------------------------------------------------------------------------- /toolbox_signal/compute_laplacian_distribution.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/compute_laplacian_distribution.m -------------------------------------------------------------------------------- /toolbox_signal/compute_laplacian_matrix.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/compute_laplacian_matrix.m -------------------------------------------------------------------------------- /toolbox_signal/dirac.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/dirac.m -------------------------------------------------------------------------------- /toolbox_signal/gen_brownian_motion.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/gen_brownian_motion.m -------------------------------------------------------------------------------- /toolbox_signal/load_sound.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/load_sound.m -------------------------------------------------------------------------------- /toolbox_signal/mex/Debug/Arith.obj: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/mex/Debug/Arith.obj -------------------------------------------------------------------------------- /toolbox_signal/mex/Debug/BitIO.obj: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/mex/Debug/BitIO.obj -------------------------------------------------------------------------------- /toolbox_signal/mex/Debug/BuildLog.htm: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/mex/Debug/BuildLog.htm -------------------------------------------------------------------------------- /toolbox_signal/mex/Debug/IntCoding.obj: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/mex/Debug/IntCoding.obj -------------------------------------------------------------------------------- /toolbox_signal/mex/Debug/ac.obj: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/mex/Debug/ac.obj -------------------------------------------------------------------------------- /toolbox_signal/mex/Debug/arcmak.obj: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/mex/Debug/arcmak.obj -------------------------------------------------------------------------------- /toolbox_signal/mex/Debug/arcode.obj: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/mex/Debug/arcode.obj -------------------------------------------------------------------------------- /toolbox_signal/mex/Debug/arcsum.obj: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/mex/Debug/arcsum.obj -------------------------------------------------------------------------------- /toolbox_signal/mex/Debug/coder.obj: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/mex/Debug/coder.obj -------------------------------------------------------------------------------- /toolbox_signal/mex/Debug/entropy.obj: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/mex/Debug/entropy.obj -------------------------------------------------------------------------------- /toolbox_signal/mex/Debug/global.obj: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/mex/Debug/global.obj -------------------------------------------------------------------------------- /toolbox_signal/mex/Debug/iHisto.obj: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/mex/Debug/iHisto.obj -------------------------------------------------------------------------------- /toolbox_signal/mex/Debug/nrutil.obj: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/mex/Debug/nrutil.obj -------------------------------------------------------------------------------- /toolbox_signal/mex/Debug/vc70.idb: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/mex/Debug/vc70.idb -------------------------------------------------------------------------------- /toolbox_signal/mex/Debug/vc70.pdb: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/mex/Debug/vc70.pdb -------------------------------------------------------------------------------- /toolbox_signal/mex/coder/images/barbara.pgm: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/mex/coder/images/barbara.pgm -------------------------------------------------------------------------------- /toolbox_signal/mex/coder/images/goldhill.pgm: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/mex/coder/images/goldhill.pgm -------------------------------------------------------------------------------- /toolbox_signal/mex/coder/images/lena512.pgm: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/mex/coder/images/lena512.pgm -------------------------------------------------------------------------------- /toolbox_signal/mex/config.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/mex/config.h -------------------------------------------------------------------------------- /toolbox_signal/mex/nr/arcmak.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/mex/nr/arcmak.cpp -------------------------------------------------------------------------------- /toolbox_signal/mex/nr/arcode.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/mex/nr/arcode.cpp -------------------------------------------------------------------------------- /toolbox_signal/mex/perform_arithmetic_coding_escape.def: -------------------------------------------------------------------------------- 1 | LIBRARY perform_arithmetic_coding_escape.dll 2 | EXPORTS 3 | mexFunction -------------------------------------------------------------------------------- /toolbox_signal/mex/perform_arithmetic_coding_fixed.def: -------------------------------------------------------------------------------- 1 | LIBRARY perform_arithmetic_coding_fixed.dll 2 | EXPORTS 3 | mexFunction -------------------------------------------------------------------------------- /toolbox_signal/mex/perform_arithmetic_coding_mex.def: -------------------------------------------------------------------------------- 1 | LIBRARY perform_arithmetic_coding_mex.dll 2 | EXPORTS 3 | mexFunction -------------------------------------------------------------------------------- /toolbox_signal/perform_arithmetic_coding.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/perform_arithmetic_coding.m -------------------------------------------------------------------------------- /toolbox_signal/perform_arithmetic_coding_fixed.dll: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/perform_arithmetic_coding_fixed.dll -------------------------------------------------------------------------------- /toolbox_signal/perform_arithmetic_coding_mex.dll: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/perform_arithmetic_coding_mex.dll -------------------------------------------------------------------------------- /toolbox_signal/perform_arithmetic_coding_mex.mexglx: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/perform_arithmetic_coding_mex.mexglx -------------------------------------------------------------------------------- /toolbox_signal/perform_best_dct.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/perform_best_dct.m -------------------------------------------------------------------------------- /toolbox_signal/perform_chirpz_transform.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/perform_chirpz_transform.m -------------------------------------------------------------------------------- /toolbox_signal/perform_laplacian_fitting.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/perform_laplacian_fitting.m -------------------------------------------------------------------------------- /toolbox_signal/perform_quantization.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/perform_quantization.m -------------------------------------------------------------------------------- /toolbox_signal/perform_rbf_interpolation.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/perform_rbf_interpolation.m -------------------------------------------------------------------------------- /toolbox_signal/perform_rle_coding.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/perform_rle_coding.m -------------------------------------------------------------------------------- /toolbox_signal/perform_shannon_estimation.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/perform_shannon_estimation.m -------------------------------------------------------------------------------- /toolbox_signal/perform_shannon_interpolation.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/perform_shannon_interpolation.m -------------------------------------------------------------------------------- /toolbox_signal/perform_tensorial_transform.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/perform_tensorial_transform.m -------------------------------------------------------------------------------- /toolbox_signal/perform_thresholding.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/perform_thresholding.m -------------------------------------------------------------------------------- /toolbox_signal/perform_vector_quantization.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/perform_vector_quantization.m -------------------------------------------------------------------------------- /toolbox_signal/perform_walsh_transform.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/perform_walsh_transform.m -------------------------------------------------------------------------------- /toolbox_signal/plot_best_basis.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/plot_best_basis.m -------------------------------------------------------------------------------- /toolbox_signal/rand_discr.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/rand_discr.m -------------------------------------------------------------------------------- /toolbox_signal/tests/test_arithmetic_coder.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/tests/test_arithmetic_coder.m -------------------------------------------------------------------------------- /toolbox_signal/tests/test_convolution.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/tests/test_convolution.m -------------------------------------------------------------------------------- /toolbox_signal/toolbox/array_set_val.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/toolbox/array_set_val.m -------------------------------------------------------------------------------- /toolbox_signal/toolbox/barb.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/toolbox/barb.png -------------------------------------------------------------------------------- /toolbox_signal/toolbox/clamp.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/toolbox/clamp.m -------------------------------------------------------------------------------- /toolbox_signal/toolbox/compute_grad.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/toolbox/compute_grad.m -------------------------------------------------------------------------------- /toolbox_signal/toolbox/compute_rigidity_tensor.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/toolbox/compute_rigidity_tensor.m -------------------------------------------------------------------------------- /toolbox_signal/toolbox/compute_structure_tensor.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/toolbox/compute_structure_tensor.m -------------------------------------------------------------------------------- /toolbox_signal/toolbox/lena.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/toolbox/lena.png -------------------------------------------------------------------------------- /toolbox_signal/toolbox/perform_tensor_decomp.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/toolbox/perform_tensor_decomp.m -------------------------------------------------------------------------------- /toolbox_signal/toolbox/perform_tensor_recomp.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/toolbox/perform_tensor_recomp.m -------------------------------------------------------------------------------- /toolbox_signal/toolbox/perform_vf_normalization.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/toolbox/perform_vf_normalization.m -------------------------------------------------------------------------------- /toolbox_signal/toolbox/plot_scattered.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/toolbox/plot_scattered.m -------------------------------------------------------------------------------- /toolbox_signal/toolbox/plot_tensor_field.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/toolbox/plot_tensor_field.m -------------------------------------------------------------------------------- /toolbox_signal/toolbox/prod_tf_sf.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/toolbox/prod_tf_sf.m -------------------------------------------------------------------------------- /toolbox_signal/toolbox/prod_tf_tf.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/toolbox/prod_tf_tf.m -------------------------------------------------------------------------------- /toolbox_signal/toolbox/prod_tf_vf.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/toolbox/prod_tf_vf.m -------------------------------------------------------------------------------- /toolbox_signal/toolbox/prod_vf_sf.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/toolbox/prod_vf_sf.m -------------------------------------------------------------------------------- /toolbox_signal/toolbox/prod_vf_vf.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_signal/toolbox/prod_vf_vf.m -------------------------------------------------------------------------------- /toolbox_sparsity/callback_atrou.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/callback_atrou.m -------------------------------------------------------------------------------- /toolbox_sparsity/html/content.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/html/content.png -------------------------------------------------------------------------------- /toolbox_sparsity/html/content_01.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/html/content_01.png -------------------------------------------------------------------------------- /toolbox_sparsity/html/content_02.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/html/content_02.png -------------------------------------------------------------------------------- /toolbox_sparsity/html/content_03.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/html/content_03.png -------------------------------------------------------------------------------- /toolbox_sparsity/html/content_04.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/html/content_04.png -------------------------------------------------------------------------------- /toolbox_sparsity/html/content_05.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/html/content_05.png -------------------------------------------------------------------------------- /toolbox_sparsity/html/content_06.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/html/content_06.png -------------------------------------------------------------------------------- /toolbox_sparsity/html/content_07.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/html/content_07.png -------------------------------------------------------------------------------- /toolbox_sparsity/html/content_08.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/html/content_08.png -------------------------------------------------------------------------------- /toolbox_sparsity/html/content_09.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/html/content_09.png -------------------------------------------------------------------------------- /toolbox_sparsity/html/content_10.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/html/content_10.png -------------------------------------------------------------------------------- /toolbox_sparsity/html/content_11.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/html/content_11.png -------------------------------------------------------------------------------- /toolbox_sparsity/html/content_12.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/html/content_12.png -------------------------------------------------------------------------------- /toolbox_sparsity/html/content_13.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/html/content_13.png -------------------------------------------------------------------------------- /toolbox_sparsity/html/content_14.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/html/content_14.png -------------------------------------------------------------------------------- /toolbox_sparsity/html/content_15.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/html/content_15.png -------------------------------------------------------------------------------- /toolbox_sparsity/html/content_16.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/html/content_16.png -------------------------------------------------------------------------------- /toolbox_sparsity/html/content_17.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/html/content_17.png -------------------------------------------------------------------------------- /toolbox_sparsity/mex/config.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/mex/config.h -------------------------------------------------------------------------------- /toolbox_sparsity/perform_iterative_thresholding.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/perform_iterative_thresholding.m -------------------------------------------------------------------------------- /toolbox_sparsity/perform_l1ball_projection.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/perform_l1ball_projection.m -------------------------------------------------------------------------------- /toolbox_sparsity/perform_omp_mex.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/perform_omp_mex.mexmaci -------------------------------------------------------------------------------- /toolbox_sparsity/perform_tv_denoising.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/perform_tv_denoising.m -------------------------------------------------------------------------------- /toolbox_sparsity/toolbox/barb.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/toolbox/barb.png -------------------------------------------------------------------------------- /toolbox_sparsity/toolbox/c3wpt.dll: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/toolbox/c3wpt.dll -------------------------------------------------------------------------------- /toolbox_sparsity/toolbox/c3wpt.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/toolbox/c3wpt.mexmaci -------------------------------------------------------------------------------- /toolbox_sparsity/toolbox/c3wpti.dll: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/toolbox/c3wpti.dll -------------------------------------------------------------------------------- /toolbox_sparsity/toolbox/c3wpti.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/toolbox/c3wpti.mexmaci -------------------------------------------------------------------------------- /toolbox_sparsity/toolbox/clamp.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/toolbox/clamp.m -------------------------------------------------------------------------------- /toolbox_sparsity/toolbox/compute_fourier_matrix.m: -------------------------------------------------------------------------------- 1 | function W = compute_fourier_matrix(n) 2 | 3 | [Y,X] = meshgrid(0:n-1,0:n-1); 4 | W = 1/sqrt(n) * exp( -1i/n *X.*Y ); -------------------------------------------------------------------------------- /toolbox_sparsity/toolbox/compute_gaussian_filter.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/toolbox/compute_gaussian_filter.m -------------------------------------------------------------------------------- /toolbox_sparsity/toolbox/compute_haar_matrix.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/toolbox/compute_haar_matrix.m -------------------------------------------------------------------------------- /toolbox_sparsity/toolbox/compute_random_patches.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/toolbox/compute_random_patches.m -------------------------------------------------------------------------------- /toolbox_sparsity/toolbox/cwpt2.dll: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/toolbox/cwpt2.dll -------------------------------------------------------------------------------- /toolbox_sparsity/toolbox/cwpt2.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/toolbox/cwpt2.mexmaci -------------------------------------------------------------------------------- /toolbox_sparsity/toolbox/cwpt2_btree.dll: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/toolbox/cwpt2_btree.dll -------------------------------------------------------------------------------- /toolbox_sparsity/toolbox/cwpt2_btree.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/toolbox/cwpt2_btree.mexmaci -------------------------------------------------------------------------------- /toolbox_sparsity/toolbox/cwpt2i.dll: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/toolbox/cwpt2i.dll -------------------------------------------------------------------------------- /toolbox_sparsity/toolbox/cwpt2i.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/toolbox/cwpt2i.mexmaci -------------------------------------------------------------------------------- /toolbox_sparsity/toolbox/imageplot.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/toolbox/imageplot.m -------------------------------------------------------------------------------- /toolbox_sparsity/toolbox/lena.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/toolbox/lena.png -------------------------------------------------------------------------------- /toolbox_sparsity/toolbox/mdwt.dll: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/toolbox/mdwt.dll -------------------------------------------------------------------------------- /toolbox_sparsity/toolbox/mdwt.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/toolbox/mdwt.mexmaci -------------------------------------------------------------------------------- /toolbox_sparsity/toolbox/midwt.dll: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/toolbox/midwt.dll -------------------------------------------------------------------------------- /toolbox_sparsity/toolbox/midwt.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/toolbox/midwt.mexmaci -------------------------------------------------------------------------------- /toolbox_sparsity/toolbox/mirdwt.dll: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/toolbox/mirdwt.dll -------------------------------------------------------------------------------- /toolbox_sparsity/toolbox/mirdwt.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/toolbox/mirdwt.mexmaci -------------------------------------------------------------------------------- /toolbox_sparsity/toolbox/mrdwt.dll: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/toolbox/mrdwt.dll -------------------------------------------------------------------------------- /toolbox_sparsity/toolbox/mrdwt.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/toolbox/mrdwt.mexmaci -------------------------------------------------------------------------------- /toolbox_sparsity/toolbox/progressbar.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/toolbox/progressbar.m -------------------------------------------------------------------------------- /toolbox_sparsity/toolbox/psnr.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_sparsity/toolbox/psnr.m -------------------------------------------------------------------------------- /toolbox_tensor_voting/compute_ball_tf.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_tensor_voting/compute_ball_tf.m -------------------------------------------------------------------------------- /toolbox_tensor_voting/compute_stick_tf.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_tensor_voting/compute_stick_tf.m -------------------------------------------------------------------------------- /toolbox_tensor_voting/perform_voting.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_tensor_voting/perform_voting.m -------------------------------------------------------------------------------- /toolbox_tensor_voting/perform_voting_ball.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_tensor_voting/perform_voting_ball.m -------------------------------------------------------------------------------- /toolbox_tensor_voting/toolbox/compute_diff.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_tensor_voting/toolbox/compute_diff.m -------------------------------------------------------------------------------- /toolbox_tensor_voting/toolbox/compute_grad.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_tensor_voting/toolbox/compute_grad.m -------------------------------------------------------------------------------- /toolbox_tensor_voting/toolbox/compute_hessian.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_tensor_voting/toolbox/compute_hessian.m -------------------------------------------------------------------------------- /toolbox_tensor_voting/toolbox/compute_laplacian.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_tensor_voting/toolbox/compute_laplacian.m -------------------------------------------------------------------------------- /toolbox_tensor_voting/toolbox/compute_operator_1.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_tensor_voting/toolbox/compute_operator_1.m -------------------------------------------------------------------------------- /toolbox_tensor_voting/toolbox/compute_operator_2.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_tensor_voting/toolbox/compute_operator_2.m -------------------------------------------------------------------------------- /toolbox_tensor_voting/toolbox/main.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_tensor_voting/toolbox/main.m -------------------------------------------------------------------------------- /toolbox_tensor_voting/toolbox/perform_convolution.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_tensor_voting/toolbox/perform_convolution.m -------------------------------------------------------------------------------- /toolbox_tensor_voting/toolbox/plot_curve.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_tensor_voting/toolbox/plot_curve.m -------------------------------------------------------------------------------- /toolbox_tensor_voting/toolbox/plot_tf.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_tensor_voting/toolbox/plot_tf.m -------------------------------------------------------------------------------- /toolbox_tensor_voting/toolbox/plot_vf.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_tensor_voting/toolbox/plot_vf.m -------------------------------------------------------------------------------- /toolbox_tensor_voting/toolbox/plot_vf_scaterred.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_tensor_voting/toolbox/plot_vf_scaterred.m -------------------------------------------------------------------------------- /toolbox_tensor_voting/toolbox/prod_tf_sf.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_tensor_voting/toolbox/prod_tf_sf.m -------------------------------------------------------------------------------- /toolbox_tensor_voting/toolbox/prod_tf_tf.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_tensor_voting/toolbox/prod_tf_tf.m -------------------------------------------------------------------------------- /toolbox_tensor_voting/toolbox/prod_tf_vf.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_tensor_voting/toolbox/prod_tf_vf.m -------------------------------------------------------------------------------- /toolbox_tensor_voting/toolbox/prod_vf_sf.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_tensor_voting/toolbox/prod_vf_sf.m -------------------------------------------------------------------------------- /toolbox_tensor_voting/toolbox/prod_vf_vf.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_tensor_voting/toolbox/prod_vf_vf.m -------------------------------------------------------------------------------- /toolbox_tensor_voting/toolbox/toolbox_diffc.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_tensor_voting/toolbox/toolbox_diffc.m -------------------------------------------------------------------------------- /toolbox_tensor_voting/toolbox_tensor_voting.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_tensor_voting/toolbox_tensor_voting.m -------------------------------------------------------------------------------- /toolbox_wavelet_meshes/data/earth-bw.jpg: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelet_meshes/data/earth-bw.jpg -------------------------------------------------------------------------------- /toolbox_wavelet_meshes/data/lena.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelet_meshes/data/lena.png -------------------------------------------------------------------------------- /toolbox_wavelet_meshes/gim/bunny-gim.gim: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelet_meshes/gim/bunny-gim.gim -------------------------------------------------------------------------------- /toolbox_wavelet_meshes/gim/bunny-sph.gim: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelet_meshes/gim/bunny-sph.gim -------------------------------------------------------------------------------- /toolbox_wavelet_meshes/html/content.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelet_meshes/html/content.png -------------------------------------------------------------------------------- /toolbox_wavelet_meshes/html/content_01.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelet_meshes/html/content_01.png -------------------------------------------------------------------------------- /toolbox_wavelet_meshes/html/content_02.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelet_meshes/html/content_02.png -------------------------------------------------------------------------------- /toolbox_wavelet_meshes/html/content_03.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelet_meshes/html/content_03.png -------------------------------------------------------------------------------- /toolbox_wavelet_meshes/html/content_04.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelet_meshes/html/content_04.png -------------------------------------------------------------------------------- /toolbox_wavelet_meshes/html/content_05.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelet_meshes/html/content_05.png -------------------------------------------------------------------------------- /toolbox_wavelet_meshes/html/content_06.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelet_meshes/html/content_06.png -------------------------------------------------------------------------------- /toolbox_wavelet_meshes/html/content_07.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelet_meshes/html/content_07.png -------------------------------------------------------------------------------- /toolbox_wavelet_meshes/perform_mesh_subdivision.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelet_meshes/perform_mesh_subdivision.m -------------------------------------------------------------------------------- /toolbox_wavelet_meshes/perform_sgim_sampling.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelet_meshes/perform_sgim_sampling.m -------------------------------------------------------------------------------- /toolbox_wavelet_meshes/toolbox/clamp.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelet_meshes/toolbox/clamp.m -------------------------------------------------------------------------------- /toolbox_wavelet_meshes/toolbox/compute_normal.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelet_meshes/toolbox/compute_normal.m -------------------------------------------------------------------------------- /toolbox_wavelet_meshes/toolbox/griddata_arbitrary.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelet_meshes/toolbox/griddata_arbitrary.m -------------------------------------------------------------------------------- /toolbox_wavelet_meshes/toolbox/keep_above.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelet_meshes/toolbox/keep_above.m -------------------------------------------------------------------------------- /toolbox_wavelet_meshes/toolbox/keep_biggest.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelet_meshes/toolbox/keep_biggest.m -------------------------------------------------------------------------------- /toolbox_wavelet_meshes/toolbox/plot_mesh.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelet_meshes/toolbox/plot_mesh.m -------------------------------------------------------------------------------- /toolbox_wavelet_meshes/toolbox/progressbar.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelet_meshes/toolbox/progressbar.m -------------------------------------------------------------------------------- /toolbox_wavelet_meshes/toolbox/read_gim.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelet_meshes/toolbox/read_gim.m -------------------------------------------------------------------------------- /toolbox_wavelet_meshes/toolbox/read_off.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelet_meshes/toolbox/read_off.m -------------------------------------------------------------------------------- /toolbox_wavelet_meshes/toolbox/rescale.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelet_meshes/toolbox/rescale.m -------------------------------------------------------------------------------- /toolbox_wavelet_meshes/toolbox/write_gim.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelet_meshes/toolbox/write_gim.m -------------------------------------------------------------------------------- /toolbox_wavelets/c3wpt.dll: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/c3wpt.dll -------------------------------------------------------------------------------- /toolbox_wavelets/c3wpt.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/c3wpt.mexmaci -------------------------------------------------------------------------------- /toolbox_wavelets/c3wpti.dll: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/c3wpti.dll -------------------------------------------------------------------------------- /toolbox_wavelets/c3wpti.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/c3wpti.mexmaci -------------------------------------------------------------------------------- /toolbox_wavelets/compute_haar_matrix.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/compute_haar_matrix.m -------------------------------------------------------------------------------- /toolbox_wavelets/compute_quadrant_selection.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/compute_quadrant_selection.m -------------------------------------------------------------------------------- /toolbox_wavelets/convert_wavelet2vect.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/convert_wavelet2vect.m -------------------------------------------------------------------------------- /toolbox_wavelets/corrDn.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/corrDn.mexmaci -------------------------------------------------------------------------------- /toolbox_wavelets/cwpt2.dll: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/cwpt2.dll -------------------------------------------------------------------------------- /toolbox_wavelets/cwpt2.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/cwpt2.mexmaci -------------------------------------------------------------------------------- /toolbox_wavelets/cwpt2_btree.dll: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/cwpt2_btree.dll -------------------------------------------------------------------------------- /toolbox_wavelets/cwpt2_btree.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/cwpt2_btree.mexmaci -------------------------------------------------------------------------------- /toolbox_wavelets/cwpt2i.dll: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/cwpt2i.dll -------------------------------------------------------------------------------- /toolbox_wavelets/cwpt2i.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/cwpt2i.mexmaci -------------------------------------------------------------------------------- /toolbox_wavelets/histo.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/histo.mexmaci -------------------------------------------------------------------------------- /toolbox_wavelets/html/content.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/html/content.png -------------------------------------------------------------------------------- /toolbox_wavelets/html/content_01.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/html/content_01.png -------------------------------------------------------------------------------- /toolbox_wavelets/html/content_02.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/html/content_02.png -------------------------------------------------------------------------------- /toolbox_wavelets/html/content_03.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/html/content_03.png -------------------------------------------------------------------------------- /toolbox_wavelets/html/content_04.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/html/content_04.png -------------------------------------------------------------------------------- /toolbox_wavelets/html/content_05.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/html/content_05.png -------------------------------------------------------------------------------- /toolbox_wavelets/html/content_06.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/html/content_06.png -------------------------------------------------------------------------------- /toolbox_wavelets/html/content_07.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/html/content_07.png -------------------------------------------------------------------------------- /toolbox_wavelets/html/content_08.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/html/content_08.png -------------------------------------------------------------------------------- /toolbox_wavelets/html/content_09.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/html/content_09.png -------------------------------------------------------------------------------- /toolbox_wavelets/html/content_10.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/html/content_10.png -------------------------------------------------------------------------------- /toolbox_wavelets/image_to_j2k.exe: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/image_to_j2k.exe -------------------------------------------------------------------------------- /toolbox_wavelets/j2k_to_image.exe: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/j2k_to_image.exe -------------------------------------------------------------------------------- /toolbox_wavelets/jbgtopbm.exe: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/jbgtopbm.exe -------------------------------------------------------------------------------- /toolbox_wavelets/jbig1.dll: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/jbig1.dll -------------------------------------------------------------------------------- /toolbox_wavelets/jp2_class.mexglx: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/jp2_class.mexglx -------------------------------------------------------------------------------- /toolbox_wavelets/lifting/get_lifting_param.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/lifting/get_lifting_param.m -------------------------------------------------------------------------------- /toolbox_wavelets/lifting/perform_79_transform.dll: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/lifting/perform_79_transform.dll -------------------------------------------------------------------------------- /toolbox_wavelets/lifting/readme: -------------------------------------------------------------------------------- 1 | This is an old code to perform wavelet transform with lifting, in C with Mex interface. -------------------------------------------------------------------------------- /toolbox_wavelets/mdwt.dll: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/mdwt.dll -------------------------------------------------------------------------------- /toolbox_wavelets/mdwt.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/mdwt.mexmaci -------------------------------------------------------------------------------- /toolbox_wavelets/mex/config.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/mex/config.h -------------------------------------------------------------------------------- /toolbox_wavelets/mex/perform_79_transform.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/mex/perform_79_transform.cpp -------------------------------------------------------------------------------- /toolbox_wavelets/mex/perform_79_transform.def: -------------------------------------------------------------------------------- 1 | LIBRARY perform_79_transform.dll 2 | EXPORTS 3 | mexFunction -------------------------------------------------------------------------------- /toolbox_wavelets/mex/perform_79_transform.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/mex/perform_79_transform.h -------------------------------------------------------------------------------- /toolbox_wavelets/mex/perform_haar_transform.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/mex/perform_haar_transform.cpp -------------------------------------------------------------------------------- /toolbox_wavelets/mex/perform_haar_transform.def: -------------------------------------------------------------------------------- 1 | LIBRARY perform_haar_transform.dll 2 | EXPORTS 3 | mexFunction -------------------------------------------------------------------------------- /toolbox_wavelets/mex/perform_haar_transform.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/mex/perform_haar_transform.h -------------------------------------------------------------------------------- /toolbox_wavelets/mex/perform_lifting_transform.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/mex/perform_lifting_transform.cpp -------------------------------------------------------------------------------- /toolbox_wavelets/mex/perform_lifting_transform.def: -------------------------------------------------------------------------------- 1 | LIBRARY perform_lifting_transform.dll 2 | EXPORTS 3 | mexFunction -------------------------------------------------------------------------------- /toolbox_wavelets/mex/perform_lifting_transform.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/mex/perform_lifting_transform.h -------------------------------------------------------------------------------- /toolbox_wavelets/midwt.dll: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/midwt.dll -------------------------------------------------------------------------------- /toolbox_wavelets/midwt.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/midwt.mexmaci -------------------------------------------------------------------------------- /toolbox_wavelets/mirdwt.dll: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/mirdwt.dll -------------------------------------------------------------------------------- /toolbox_wavelets/mirdwt.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/mirdwt.mexmaci -------------------------------------------------------------------------------- /toolbox_wavelets/mrdwt.dll: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/mrdwt.dll -------------------------------------------------------------------------------- /toolbox_wavelets/mrdwt.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/mrdwt.mexmaci -------------------------------------------------------------------------------- /toolbox_wavelets/pbmtojbg.exe: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/pbmtojbg.exe -------------------------------------------------------------------------------- /toolbox_wavelets/perform_circle_haar_transform.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/perform_circle_haar_transform.m -------------------------------------------------------------------------------- /toolbox_wavelets/perform_cpx_dualtree_transform.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/perform_cpx_dualtree_transform.m -------------------------------------------------------------------------------- /toolbox_wavelets/perform_haar_transform.dll: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/perform_haar_transform.dll -------------------------------------------------------------------------------- /toolbox_wavelets/perform_haar_transform.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/perform_haar_transform.mexmaci -------------------------------------------------------------------------------- /toolbox_wavelets/perform_haar_transform_1d.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/perform_haar_transform_1d.m -------------------------------------------------------------------------------- /toolbox_wavelets/perform_haar_transform_slow.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/perform_haar_transform_slow.m -------------------------------------------------------------------------------- /toolbox_wavelets/perform_jbig_coding.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/perform_jbig_coding.m -------------------------------------------------------------------------------- /toolbox_wavelets/perform_jp2k_compression.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/perform_jp2k_compression.m -------------------------------------------------------------------------------- /toolbox_wavelets/perform_jp2k_degradation.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/perform_jp2k_degradation.m -------------------------------------------------------------------------------- /toolbox_wavelets/perform_jp2k_encoding.dll: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/perform_jp2k_encoding.dll -------------------------------------------------------------------------------- /toolbox_wavelets/perform_jp2k_encoding.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/perform_jp2k_encoding.mexmaci -------------------------------------------------------------------------------- /toolbox_wavelets/perform_pyramid_transform.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/perform_pyramid_transform.m -------------------------------------------------------------------------------- /toolbox_wavelets/perform_pyramid_transform_ti.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/perform_pyramid_transform_ti.m -------------------------------------------------------------------------------- /toolbox_wavelets/perform_real_dualtree_transform.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/perform_real_dualtree_transform.m -------------------------------------------------------------------------------- /toolbox_wavelets/perform_spaciowav_matching.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/perform_spaciowav_matching.m -------------------------------------------------------------------------------- /toolbox_wavelets/perform_wavelet_jp2k_coding.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/perform_wavelet_jp2k_coding.m -------------------------------------------------------------------------------- /toolbox_wavelets/perform_wavelet_transform.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/perform_wavelet_transform.m -------------------------------------------------------------------------------- /toolbox_wavelets/plot_quincunx_wavelet.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/plot_quincunx_wavelet.m -------------------------------------------------------------------------------- /toolbox_wavelets/plot_wavelet.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/plot_wavelet.m -------------------------------------------------------------------------------- /toolbox_wavelets/pointOp.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/pointOp.mexmaci -------------------------------------------------------------------------------- /toolbox_wavelets/range2.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/range2.mexmaci -------------------------------------------------------------------------------- /toolbox_wavelets/reorder_coefs.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/reorder_coefs.m -------------------------------------------------------------------------------- /toolbox_wavelets/tests/test_circle_haar.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/tests/test_circle_haar.m -------------------------------------------------------------------------------- /toolbox_wavelets/tests/test_compression.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/tests/test_compression.m -------------------------------------------------------------------------------- /toolbox_wavelets/tests/test_wavelet.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/tests/test_wavelet.m -------------------------------------------------------------------------------- /toolbox_wavelets/toolbox/apply_tensorial.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/toolbox/apply_tensorial.m -------------------------------------------------------------------------------- /toolbox_wavelets/toolbox/clamp.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/toolbox/clamp.m -------------------------------------------------------------------------------- /toolbox_wavelets/toolbox/hair.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/toolbox/hair.png -------------------------------------------------------------------------------- /toolbox_wavelets/toolbox/imageplot.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/toolbox/imageplot.m -------------------------------------------------------------------------------- /toolbox_wavelets/toolbox/keep_biggest.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/toolbox/keep_biggest.m -------------------------------------------------------------------------------- /toolbox_wavelets/toolbox/lena.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/toolbox/lena.png -------------------------------------------------------------------------------- /toolbox_wavelets/toolbox/perform_quantization.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/toolbox/perform_quantization.m -------------------------------------------------------------------------------- /toolbox_wavelets/toolbox/rescale.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/toolbox/rescale.m -------------------------------------------------------------------------------- /toolbox_wavelets/upConv.dll: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/upConv.dll -------------------------------------------------------------------------------- /toolbox_wavelets/upConv.mexmaci: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gpeyre/matlab-toolboxes/0cd622c988cda6f63f64d35cd7bd096fa578e5c6/toolbox_wavelets/upConv.mexmaci --------------------------------------------------------------------------------