27.04.2016 21:10:34 [INFO ] [Plugin.Initialize()] Is64Bit() = 32 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwabs(1) - the absolute value of the elements of X. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mweq(2) - A == B. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwfft(1) - (X) is the discrete Fourier transform (DFT) of vector X. For matrices, the FFT operation is applied to each column. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwfft(2) - (X,N) is the N-point FFT, padded with zeros if X has less than N points and truncated if it has more. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwifft(1) - (X) is the inverse discrete Fourier transform of X. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwifft(2) - (X,N) is the N-point inverse transform. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwfft2(1) - two-dimensional fast Fourier transform. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwfind(1) - find indices and values of nonzero elements. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwfprintf(4) - [file, permission, format, data] - write formatted data to file. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwge(2) - A >= B. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwgt(2) - A > B. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwifft2(1) - two-dimensional inverse discrete Fourier transform. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwfftshift(1) - (X,DIM) applies the FFTSHIFT operation along the dimension DIM. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwfftshift(2) - Shift zero-frequency component to center of spectrum. For vectors, FFTSHIFT(X) swaps the left and right halves of X. For matrices, FFTSHIFT(X) swaps the first and third quadrants and the second and fourth quadrants. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwifftshift(1) - For vectors, IFFTSHIFT(X) swaps the left and right halves of X. For matrices, IFFTSHIFT(X) swaps the first and third quadrants and the second and fourth quadrants. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwifftshift(2) - (X,DIM) applies the IFFTSHIFT operation along the dimension DIM. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwle(2) - A <= B. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwlt(2) - A < B. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwneq(2) - A ~= B. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwsign(1) - signum function. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwfscanf(3) - ( file, permission, format ) - read formatted data from file. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwfscanf(4) - ( file, permission, format, size ) - read formatted data from file. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwode45(5) - (init, x1, x2, intvls, D) solve non-stiff differential equations, medium order method. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwode23(5) - (init, x1, x2, intvls, D) solve non-stiff differential equations, low order method. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwode113(5) - (init, x1, x2, intvls, D) solve non-stiff differential equations, variable order method. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwode15s(5) - (init, x1, x2, intvls, D) solve stiff differential equations and DAEs, variable order method. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwode23s(5) - (init, x1, x2, intvls, D) solve stiff differential equations, low order method. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwand(2) - A & B is a matrix whose elements are 1's where both A and B have non-zero elements, and 0's where either has a zero element. A and B must have the same dimensions unless one is a scalar. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwor(2) - A | B is a matrix whose elements are 1's where either A or B has a non-zero element, and 0's where both have zero elements. A and B must have the same dimensions unless one is a scalar. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwnot(1) - ~A is a matrix whose elements are 1's where A has zero elements, and 0's where A has non-zero elements. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwacos(1) - inverse cosine. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwacosh(1) - inverse hyperbolic cosine. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwacot(1) - inverse cotangent. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwacoth(1) - inverse hyperbolic cotangent. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwacsc(1) - inverse cosecant. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwacsch(1) - inverse hyperbolic cosecant. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwall(1) - ( A ) test to determine if all elements are nonzero. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwall(2) - ( A, DIM ) test to determine if all elements are nonzero. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwangle(1) - phase angle. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwany(1) - ( A ) for any nonzeros. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwany(2) - ( A, DIM ) test for any nonzeros. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwasec(1) - inverse secant. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwasech(1) - inverse hyperbolic secant. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwasin(1) - inverse sine. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwasinh(1) - inverse hyperbolic sine. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwatan(1) - inverse tangent. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwatanh(1) - inverse hyperbolic tangent. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwatan2(2) - ( Y, X ) four-quadrant inverse tangent. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwbalance(1) - diagonal scaling to improve eigenvalue accuracy. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwbesseli(2) - (NU,Z) is the modified Bessel function of the first kind, I_nu(Z). The order NU need not be an integer, but must be real. The argument Z can be complex. The result is real where Z is positive 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwbesselj(2) - (NU,Z) is the Bessel function of the first kind, J_nu(Z). The order NU need not be an integer, but must be real. The argument Z can be complex. The result is real where Z is positive. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwbesselh(3) - (NU,K,Z), for K = 1 or 2, computes the Hankel function H1_nu(Z) or H2_nu(Z) for each element of the complex array Z. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwbesselk(2) - (NU,Z) is the modified Bessel function of the second kind, K_nu(Z). The order NU need not be an integer, but must be real. The argument Z can be complex. The result is real where Z is positive. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwbessely(2) - (NU,Z) is the Bessel function of the second kind, Y_nu(Z). The order NU need not be an integer, but must be real. The argument Z can be complex. The result is real where Z is positive 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwbeta(2) - (Z,W) computes the beta function for corresponding elements of Z and W. The beta function is defined as beta(z,w) = integral from 0 to 1 of t.^(z-1) .* (1-t).^(w-1) dt. The arrays Z and W must be the same size (or either can be scalar). 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwbetainc(3) - (X,Z,W) computes the incomplete beta function for corresponding elements of X, Z, and W. The elements of X must be in the closed interval [0,1]. The arguments X, Z and W must all be the same size (or any of them can be scalar). 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwbetaln(2) - (Z,W) computes the natural logarithm of the beta function for corresponding elements of Z and W. The arrays Z and W must be the same size (or either can be scalar). BETALN is defined as: BETALN = LOG(BETA(Z,W)) and is obtained without computing BETA(Z,W). Since the beta function can range over very large or very small values, its logarithm is sometimes more useful 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwbin2dec(1) - convert binary string to decimal integer. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwbitand(2) - (A,B) returns the bit-wise AND of the two arguments A and B. Both A and B must contain non-negative integers between 0 and BITMAX. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwbitcmp(2) - (A,N) returns the bit-wise complement of A as an N-bit non-negative integer. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwbitor(2) - (A,B) returns the bit-wise OR of the two arguments A and B. Both A and B must contain non-negative integers between 0 and BITMAX. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwbitxor(2) - (A,B) returns the bit-wise exclusive OR of the two arguments A and B. Both A and B must contain non-negative integers between 0 and BITMAX. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwcart2pol(2) - (X,Y) transforms corresponding elements of data stored in Cartesian coordinates X,Y to polar coordinates (angle TH and radius R). The arrays X and Y must be the same size (or either can be scalar). TH is returned in radians. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwcart2pol(3) - (X,Y,Z) transforms corresponding elements of data stored in Cartesian coordinates X,Y,Z to cylindrical coordinates (angle TH, radius R, and height Z). The arrays X,Y, and Z must be the same size (or any of them can be scalar). TH is returned in radians. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwcart2sph(3) - (X,Y,Z) transforms corresponding elements of data stored in Cartesian coordinates X,Y,Z to spherical coordinates (azimuth TH, elevation PHI, and radius R). The arrays X,Y, and Z must be the same size (or any of them can be scalar). TH and PHI are returned in radians. TH is the counterclockwise angle in the xy plane measured from the positive x axis. PHI is the elevation angle from the xy plane 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwceil(1) - (X) rounds the elements of X to the nearest integers towards infinity. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwchol(1) - (X) uses only the diagonal and upper triangle of X. The lower triangular is assumed to be the (complex conjugate) transpose of the upper. If X is positive definite, then R = CHOL(X) produces an upper triangular R so that R'*R = X. If X is not positive definite, an error message is printed. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwconj(1) - (X) is the complex conjugate of X. For a complex X, CONJ(X) = REAL(X) - i*IMAG(X). 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwconv(2) - (A, B) convolves vectors A and B. The resulting vector is length LENGTH(A)+LENGTH(B)-1. If A and B are vectors of polynomial coefficients, convolving them is equivalent to multiplying the two polynomials. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwconv2(2) - (A, B) performs the 2-D convolution of matrices A and B. If [ma,na] = size(A) and [mb,nb] = size(B), then size(C) = [ma+mb-1,na+nb-1]. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwcorrcoef(1) - (X) calculates a matrix R of correlation coefficients for an array X, in which each row is an observation and each column is a variable. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwcorrcoef(2) - (X,Y), where X and Y are column vectors, is the same as R=CORRCOEF([X Y]). 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwcov(1) - (X), if X is a vector, returns the variance. For matrices, where each row is an observation, and each column a variable, COV(X) is the covariance matrix. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwcov(2) - (X,Y), where X and Y are vectors of equal length, is equivalent to COV([X(:) Y(:)]). 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwcos(1) - cosine. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwcosh(1) - hyperbolic cosine. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwcot(1) - cotangent. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwcoth(1) - hyperbolic cotangent. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwcsc(1) - cosecant. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwcsch(1) - hyperbolic cosecant. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwdet(1) - (X) is the determinant of the square matrix X. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwexp(1) - (X) is the exponential of the elements of X, e to the X. For complex Z=X+i*Y, EXP(Z) = EXP(X)*(COS(Y)+i*SIN(Y)) 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwexpint(1) - (X) is the exponential integral function for each element of X. The exponential integral is defined as: EXPINT(x) = integral from X to Inf of (exp(-t)/t) dt, for x > 0. By analytic continuation, EXPINT is a single-valued function in the complex plane cut along the negative real axis. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwexpm(1) - (X) is the matrix exponential of X. EXPM is computed using a scaling and squaring algorithm with a Pade approximation. EXP(X) computes the exponential of X element-by-element. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mweye(1) - (N) is the N-by-N identity matrix. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mweye(2) - (N,M) is an N-by-M matrix with 1's on the diagonal and zeros elsewhere. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwfactor(1) - (N) returns a vector containing the prime factors of N. This function uses the simple sieve approach. It may require large memory allocation if the number given is too big. Technically it is possible to improve this algorithm, allocating less memory for most cases and resulting in a faster execution time. However, it will still have problems in the worst case, so we choose to impose an upper bound on the input number and error out for n > 2^32. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwfix(1) - (X) rounds the elements of X to the nearest integers towards zero. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwfloor(1) - (X) rounds the elements of X to the nearest integers towards minus infinity. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwimag(1) - (X) is the imaginary part of X. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwisprime(1) - (X) is 1 for the elements of X that are prime, 0 otherwise. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwlog(1) - (X) is the natural logarithm of the elements of X. Complex results are produced if X is not positive. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwlogm(1) - (A) is the matrix logarithm of A, the inverse of EXPM(A). Complex results are produced if A has negative eigenvalues. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwmean(1) - For vectors, MEAN(X) is the mean value of the elements in X. For matrices, MEAN(X) is a row vector containing the mean value of each column. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwmean(2) - (X,DIM) takes the mean along the dimension DIM of X. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwmedian(1) - For vectors, MEDIAN(X) is the median value of the elements in X. For matrices, MEDIAN(X) is a row vector containing the median value of each column. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwmedian(2) - (X,DIM) takes the median along the dimension DIM of X. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwmod(2) - (x,y) is x - n.*y where n = floor(x./y) if y ~= 0. If y is not an integer and the quotient x./y is within roundoff error of an integer, then n is that integer. By convention, MOD(x,0) is x. The input x and y must be real arrays of the same size, or real scalars. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwnextpow2(1) - (N) returns the first P such that 2^P >= abs(N). It is often useful for finding the nearest power of two sequence length for FFT operations. NEXTPOW2(X), if X is a vector, is the same as NEXTPOW2(LENGTH(X)). 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwnnz(1) - (S) is the number of nonzero elements in S. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwnonzeros(1) - (S) is a full column vector of the nonzero elements of S. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwones(1) - (N) is an N-by-N matrix of ones. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwones(2) - (N,M) is an N-by-M matrix of ones. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwprimes(1) - (N) is a row vector of the prime numbers less than or equal to N. A prime number is one that has no factors other than 1 and itself. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwrand(1) - (N) is an N-by-N matrix with random entries, chosen from a uniform distribution on the interval (0.0,1.0). 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwrand(2) - (N,M) are N-by-M matrices with random entries, chosen from a uniform distribution on the interval (0.0,1.0). 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwrandn(1) - (N) is an N-by-N matrix with random entries, chosen from a normal distribution with mean zero, variance one and standard deviation one. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwrandn(2) - (N,M) are N-by-M matrices with random entries, chosen from a normal distribution with mean zero, variance one and standard deviation one. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwreal(1) - (X) is the real part of X. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwrem(2) - (x,y) is x - n.*y where n = fix(x./y) if y ~= 0. If y is not an integer and the quotient x./y is within roundoff error of an integer, then n is that integer. By convention, REM(x,0) is NaN. The input x and y must be real arrays of the same size, or real scalars. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwroots(1) - (C) computes the roots of the polynomial whose coefficients are the elements of the vector C. If C has N+1 components, the polynomial is C(1)*X^N + ... + C(N)*X + C(N+1). 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwrot90(1) - (A) is the 90 degree counterclockwise rotation of matrix A. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwrot90(2) - (A,K) is the K*90 degree rotation of A, K = +-1,+-2,... 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwround(1) - (X) rounds the elements of X to the nearest integers. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwsec(1) - secant. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwsech(1) - hyperbolic secant. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwsin(1) - sine. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwsinh(1) - hyperbolic sine. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwsize(1) - (X), for M-by-N matrix X, returns the two-element row vector D = [M, N] containing the number of rows and columns in the matrix. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwstd(1) - For vectors, STD(X) returns the standard deviation. For matrices, STD(X) is a row vector containing the standard deviation of each column. STD(X) normalizes by (N-1) where N is the sequence length. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwstd(2) - (X,1) normalizes by N and produces the square root of the second moment of the sample about its mean. STD(X,0) is the same as STD(X). 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwstd(5) - (X,1) normalizes by N and produces the square root of the second moment of the sample about its mean. STD(X,0) is the same as STD(X). 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwsum(1) - For vectors, SUM(X) is the sum of the elements of X. For matrices, SUM(X) is a row vector with the sum over each column. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwsum(2) - (X,DIM) sums along the dimension DIM. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwsqrt(1) - (X) is the square root of the elements of X. Complex results are produced if X is not positive. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwsqrtm(1) - (A) is the principal square root of the matrix A, i.e. X*X = A. X is the unique square root for which every eigenvalue has nonnegative real part. If A has any eigenvalues with negative real parts then a complex result is produced. If A is singular then A may not have a square root. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwtan(1) - (X) is the tangent of the elements of X. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwtanh(1) - (X) is the hyperbolic tangent of the elements of X. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwtrace(1) - (A) is the sum of the diagonal elements of A, which is also the sum of the eigenvalues of A. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwtril(1) - (X) is the lower triangular part of X. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwtril(2) - (X,K) is the elements on and below the K-th diagonal of X . K = 0 is the main diagonal, K > 0 is above the main diagonal and K < 0 is below the main diagonal. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwtriu(1) - (X) is the upper triangular part of X. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwtriu(2) - (X,K) is the elements on and above the K-th diagonal of X. K = 0 is the main diagonal, K > 0 is above the main diagonal and K < 0 is below the main diagonal. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwxor(2) - (S,T) is the logical symmetric difference of elements S and T. The result is one where either S or T, but not both, is nonzero. The result is zero where S and T are both zero or nonzero. S and T must have the same dimensions (or one can be a scalar). 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwzeros(1) - (N) is an N-by-N matrix of zeros. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] mwzeros(2) - (N,M) is an N-by-M matrix of zeros. 27.04.2016 21:10:46 [INFO ] [Plugin.Initialize()] Successfully. 136 functions loaded.