سورس کد های متلب - 100 تای دوم


امتیاز موضوع:
  • 1 رای - 1 میانگین
  • 1
  • 2
  • 3
  • 4
  • 5

[-]
کلمات کلیدی
دوم متلب های سورس کد تای 100

سورس کد های متلب - 100 تای دوم
#1
cg, a library which implements a simple version of the conjugate gradient (CG) method for solving a system of linear equations of the form A*x=b, suitable for situations in which the matrix A is positive definite (only real, positive eigenvalues) and symmetric.
cg_distributed, a program which implements a version of the NAS conjugate gradient (CG) benchmark, using distributed memory.
cg_lab_triangles, a collection of programs associated with a computer lab assignment on computational geometry and triangles;
cg_rc, a library which implements the conjugate gradient (CG) method for solving a positive definite sparse linear system A*x=b, using reverse communication (RC).
chain_letter_tree, a program which analyzes a similarity matrix for 11 versions of a single chain letter and produces a dendrogram or tree diagram that suggests the degrees of relatedness and the evolutionary history of the letters.
change_making, a library which considers the change making problem, in which a given sum is to be formed using coins of various denominations.
chebyshev, a library which computes the Chebyshev interpolant/approximant to a given function over an interval.
chebyshev_interp_1d, a library which determines the combination of Chebyshev polynomials which interpolates a set of data, so that p(x(i)) = y(i).
chebyshev_polynomial, a library which considers the Chebyshev polynomials T(i,x), U(i,x), V(i,x) and W(i,x). Functions are provided to evaluate the polynomials, determine their zeros, produce their polynomial coefficients, produce related quadrature rules, project other functions onto these polynomial bases, and integrate double and triple products of the polynomials.
chebyshev_series, a library which can evaluate a Chebyshev series approximating a function f(x), while efficiently computing one, two or three derivatives of the series, which approximate f'(x), f''(x), and f'''(x), by Manfred Zimmer.
chebyshev1_rule, a program which computes and writes out a Gauss-Chebyshev type 1 quadrature rule of given order.
chebyshev2_rule, a program which computes and writes out a Gauss-Chebyshev type 2 quadrature rule of given order.
chrpak, a library which manipulates characters and strings;
circle_arc_grid, a program which computes grid points along a circular arc.
circle_grid_display a program which reads a matrix of integers, and draws a corresponding grid of circles filled with color.
circle_integrals, a library which returns the exact value of the integral of any monomial over the circumference of the unit circle in 2D.
circle_monte_carlo, a library which applies a Monte Carlo method to estimate the integral of a function along the circumference of the unit circle in 2D;
circle_rule, a library which computes quadrature rules for the unit circle in 2D, that is, the circumference of the circle of radius 1 and center (0,0).
circle_segment, a library which carries out computations associated with a circle segment, including height, angle, area, centroid, sampling, and quadrature.
circles, a library which can be used, when creating graphics, to draw one or more circles, while controlling the center locations, radii, colors, edge colors, and transparency, by Chad Greene.
cities, a library which works with city-to-city distance matrices;
clausen, a library which evaluates a Chebyshev interpolant to the Clausen function Cl2(x).
clenshaw_curtis_rule, a program which implements a Clenshaw Curtis quadrature rule;
cnoise, a library which generates samples of noise obeying a 1/f^alpha power law, by Miroslav Stoyanov.
coin_simulation, a library which looks at ways of simulating or visualizing the results of many tosses of a fair or biased coin.
collatz, a library which computes and analyzes the Collatz sequence, also known as the hailstone sequence or 3n+1 sequence;
collatz_parfor, a program which seeks the maximum Collatz sequence between 1 and N; it runs in parallel using MATLAB's parfor facility.
collatz_recursive, a library which demonstrates recursive programming by considering the simple Collatz 3n+1 problem.
collocation, a library which demonstrates some simple examples of the use of collocation to produce a function g(x) that satisfies the same constraints as a function f(x), but only at a discrete set of points.
color_remote, a program which carries out the color segmentation of an image in parallel, using MATLAB's spmd facility; this includes instructions on how to run the job, via MATLAB's batch facility, on a remote system such as Virginia Tech's ithaca cluster.
colored_noise, a library which generates samples of noise obeying a 1/f^alpha power law.
combination_lock, a program which simulates the process of determining the secret combination of a lock.
combo, a library which includes routines for ranking, unranking, enumerating and randomly selecting balanced sequences, cycles, graphs, Gray codes, subsets, partitions, permutations, restricted growth functions, Pruefer codes and trees.
compass_search, a library which seeks the minimizer of a scalar function of several variables using compass search, a direct search algorithm that does not use derivatives.
complex_numbers, a program which demonstrates some simple features involved in the use of complex numbers in programming.
complexity, programs which measure the complexity of a few simple algorithms with increasing problem size.
condition, a library which implements methods of computing or estimating the condition number of a matrix.
continuation, a library which implements the continuation method for a simple 2D problem, which involves finding a point on the unit circle, and then finding a sequence of nearby points which trace out the full curve, using only the information available in the implicit definition of the curve from the function f(x,y)=x^2+y^2-1.
contour_gradient, a program which displays contours and gradient vectors for a function f(x,y).
contour_gradient_3d, a program which displays contours and gradient vectors for a function f(x,y) in a 3D display.
contour_sequence4, a program which creates images suitable for animation from one XY file and a sequence of u(x,y) data files;
contrast_spmd, a program which demonstrates spmd parallel programming for image operations; the client reads an image, the workers heighten contrast over portions of it, and the client assembles and displays the results.
contrast2_spmd, a program which demonstrates spmd parallel programming for image operations; it improves on contrast_spmd by allowing the workers to communicate, and so eliminates artificial seams that would otherwise appear in the processed image.
convex_hull, a program which demonstrates the computation of the convex hull of a set of 2D points.
coordinate_search, a program which seeks the minimizer of a scalar function of several variables, by Jeff Borggaard.
cordic, a library which computes a few special functions using the CORDIC algorithm.
correlation, a library which contains examples of statistical correlation functions.
correlation_chebfun, a library which uses the chebfun library to compute truncated Karhunen-Loeve expansions of stochastic processes with a given correlation function.
cosine_transform, a library which demonstrates some simple properties of the discrete cosine transform (DCT).
cube_arbq_rule, a library which returns quadrature rules, with exactness up to total degree 15, over the interior of the symmetric cube in 3D, by Hong Xiao and Zydrunas Gimbutas.
cube_exactness, a library which investigates the polynomial exactness of quadrature rules over the interior of a cube in 3D.
cube_felippa_rule, a library which returns Felippa's quadratures rules for approximating integrals over the interior of a cube in 3D.
cube_grid, a library which computes a grid of points over the interior of a cube in 3D.
cube_integrals, a library which returns the exact value of the integral of any monomial over the interior of the unit cube in 3D.
cube_monte_carlo, a library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit cube in 3D.
cvt, a library which computes an N-point Centroidal Voronoi Tessellation (CVT) in M dimensions;
cvt_1d_lloyd, a program which computes an N-point Centroidal Voronoi Tessellation (CVT) within the interval [0,1], under a uniform density, using Lloyd's method to compute the Voronoi regions exactly.
cvt_1d_lumping, a program which allows the user to carry out a lumped version of Lloyd's iterative algorithm for a centroidal Voronoi Tessellation (CVT() in the interval [-1,+1], and is applied to investigate a relationship between CVT's and the Chebyshev Zero nodes.
cvt_1d_nonuniform, a program which computes an N-point Centroidal Voronoi Tessellation (CVT) in 1 dimension, under a nonuniform density, and plots the evolution of the locations of the generators during the iteration;
cvt_1d_sampling, a program which computes an N-point Centroidal Voronoi Tessellation (CVT) within the interval [0,1], under a uniform density, using sampling to estimate the Voronoi regions.
cvt_2d_lumping, a program which computes an N-point Centroidal Voronoi Tessellation (CVT) within the unit square [-1,1]^2, under a Chebyshev density, using weighted sampling ("lumping") to estimate the Voronoi regions.
cvt_2d_sampling, a program which computes an N-point Centroidal Voronoi Tessellation (CVT) within the unit square [0,1]x[0,1], under a uniform density, using sampling to estimate the Voronoi regions.
cvt_3d_lumping, a program which computes an N-point Centroidal Voronoi Tessellation (CVT) within the unit cube [-1,1]^3, under a Chebyshev density, using weighted sampling ("lumping") to estimate the Voronoi regions.
cvt_3d_sampling, a program which computes an N-point Centroidal Voronoi Tessellation (CVT) within the unit cube [0,1]x[0,1]x[0,1], under a uniform density, using sampling to estimate the Voronoi regions.
cvt_circle_nonuniform, a program which demonstrates the computation of a centroidal Voronoi Tessellation (CVT) over a circular region, using a nonuniform density.
cvt_circle_uniform, a program which demonstrates the computation of a centroidal Voronoi Tessellation (CVT) over a circular region, using a uniform density.
cvt_corn, a program which studies a 2D model of the growth of a corn kernel, by treating the surface and interior biological cells as points to be organized by a Centroidal Voronoi Tessellation (CVT) with a nonuniform density; during a sequence of growth steps, new biological cells are randomly added to the surface and interior.
cvt_dataset, a program which creates a Centroidal Voronoi Tessellation (CVT) dataset;
cvt_ellipse_uniform, a program which iteratively calculates a Centroidal Voronoi Tessellation (CVT) over an ellipse, with a uniform density.
cvt_example_fifty_points, a program which illustrates the steps involved in the calculation of a Centroidal Voronoi Tessellation (CVT) of the unit square, with 50 generator points.
cvt_example_five_points, a program which illustrates the steps involved in the calculation of a Centroidal Voronoi Tessellation (CVT) of the unit square, with 5 generator points.
cvt_metric, a program which computes a Centroidal Voronoi Tessellation (CVT) under a spatially varying metric;
cvt_movie, a program which creates an animation of the evolution of a Centroidal Voronoi Tessellation (CVT);
cvt_movie2, a program which creates a Centroidal Voronoi Tessellation (CVT) movie;
cvt_movie3, a program which creates a Centroidal Voronoi Tessellation (CVT) movie in a region of unusual shape;
cvt_movie4, a program which creates a Centroidal Voronoi Tessellation (CVT) movie in a square, with a density function that drives points to the corners;
cvt_movie5, a program which repeats cvt_movie3, but with hexagonal grid initialization, fixed points, and boundary projection;
cvt_square_nonuniform, a program which iteratively calculates a Centroidal Voronoi Tessellation (CVT) over a square, with a nonuniform density.
cvt_square_pdf_discrete, a program which iteratively calculates a Centroidal Voronoi Tessellation (CVT) over a square, with a density determined from a discrete PDF.
cvt_square_uniform, a program which iteratively calculates a Centroidal Voronoi Tessellation (CVT) over a square, with a uniform density.
cvt_triangle_uniform, a program which iteratively calculates a Centroidal Voronoi Tessellation (CVT) over a triangle, with a uniform density.
cvtm_1d, a program which estimates a mirror-periodic centroidal Voronoi Tessellation (CVTM) in the periodic interval [0,1], using a version of Lloyd's iteration.
cvtp, a library which creates a CVTP dataset, that is, a Centroidal Voronoi Tessellation on a periodic region.
cvtp_1d, a program which estimates a periodic centroidal Voronoi Tessellation (CVTP) in the periodic interval [0,1], using a version of Lloyd's iteration.
cycle_brent, a library which carries out an iterated function evaluation, and seeks to determine the nearest element of a cycle, and the cycle's length, using Brent's method.
cycle_floyd, a library which carries out an iterated function evaluation, and seeks to determine the nearest element of a cycle, and the cycle's length, using Floyd's method.
cyclic_reduction, a library which solves a tridiagonal linear system using cyclic reduction;
dfield8, a program which interactively displays the direction field of an ordinary differential equation (ODE), by John Polking.
diaphony, a program which reads a file of N points in M dimensions and computes its diaphony, a measure of point dispersion.
dice_simulation, a program which simulates N tosses of M dice, making a histogram of the results.
dictionary_code, a library which demonstates how a text file can be compressed and decompressed using a dictionary code.
differ, determines the finite difference coefficients necessary in order to combine function values at known locations to compute an approximation of given accuracy to a derivative of a given order.
dijkstra, a library which implements a simple version of Dijkstra's minimum distance algorithm for graphs.
dijkstra_spmd, a program which uses the spmd feature to parallelize a simple example of Dijkstra's minimum distance algorithm for graphs.
disk_grid, a library which computes grid points within the interior of a disk of user specified radius and center in 2D, using GNUPLOT to create an image of the grid.
disk_integrals, a library which returns the exact value of the integral of any monomial over the interior of the unit disk in 2D.
disk_monte_carlo, a library which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit disk in 2D;
disk_quarter_monte_carlo, a library which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit quarter disk in 2D;
disk_rule, a library which computes quadrature rules for the general disk in 2D, that is, the interior of the circle of radius RC and center (XC,YC).
disk01_quarter_rule, a program which computes a quadrature rule for the unit quarter disk in 2D, that is, the interior of the circle of radius 1 and center (0,0).
disk01_rule, a library which computes quadrature rules for the unit disk in 2D, that is, the interior of the circle of radius 1 and center (0,0).
پاسخ
#2
بسیار خوب و مفید بودند.
ممنون
Lumion Pro یک نرم افزار قدرتمند برای طراحی سه بعدی انواع محیط و سازه ها می باشد، به وسیله این نرم افزارمی توانید ساختمانی که قرار است ساخته شود، برج، شهرک، پارک و غیره … را از قبل طراحی کرده آن را در جهات گوناگون مشاهده نمود و تحلیل و بررسی کرد. در حقیقت Lumion یک راه حل ساده برای ایجاد ویدئو و تفاسیر سه بعدی از یک مجموعه در حال توسعه است که با دیدن نتیجه کار شما می توانید کاملاً خود را در محیط شبیه سازی شده تصور کنید. به وسیله این نرم افزار شما قادر به طراحی و شبیه سازی محیط هایی می باشید که پروژه ی آن به صورت واقعی قرار است انجام شود، و به معماران و مدیران یک پروژه و یا مسئولین شهر برای درک پروژه ی آتی و یا در حال انجام کمک بسیاری خواهد کرد،
دیدن لینک ها برای شما امکان پذیر نیست. لطفا ثبت نام کنید یا وارد حساب خود شوید تا بتوانید لینک ها را ببینید.
پاسخ


پرش به انجمن:


کاربران در حال بازدید این موضوع: 1 مهمان