Fix copyright notices

time-shift
Sébastien Villemot 2012-10-31 17:03:49 +01:00
parent f8f2c5d8a1
commit 0ab230b474
39 changed files with 78 additions and 39 deletions

View File

@ -31,7 +31,6 @@ function sp = colon(a,b)
%@eod:
% Copyright (C) 2011 Dynare Team
% stephane DOT adjemian AT univ DASH lemans DOT fr
%
% This file is part of Dynare.
%
@ -48,6 +47,8 @@ function sp = colon(a,b)
% You should have received a copy of the GNU General Public License
% along with Dynare. If not, see <http://www.gnu.org/licenses/>.
% Original author: stephane DOT adjemian AT univ DASH lemans DOT fr
if nargin~=2
error('dynTime::colon: I need exactly two input arguments!')
end

View File

@ -44,7 +44,6 @@ function date = dynDate(a)
%@eod:
% Copyright (C) 2011 Dynare Team
% stephane DOT adjemian AT univ DASH lemans DOT fr
%
% This file is part of Dynare.
%
@ -61,6 +60,8 @@ function date = dynDate(a)
% You should have received a copy of the GNU General Public License
% along with Dynare. If not, see <http://www.gnu.org/licenses/>.
% Original author: stephane DOT adjemian AT univ DASH lemans DOT fr
date = struct;
date.freq = NaN;

View File

@ -30,7 +30,6 @@ function c = eq(a,b)
%@eod:
% Copyright (C) 2011 Dynare Team
% stephane DOT adjemian AT univ DASH lemans DOT fr
%
% This file is part of Dynare.
%
@ -47,6 +46,8 @@ function c = eq(a,b)
% You should have received a copy of the GNU General Public License
% along with Dynare. If not, see <http://www.gnu.org/licenses/>.
% Original author: stephane DOT adjemian AT univ DASH lemans DOT fr
verbose = 0;
if nargin~=2

View File

@ -28,7 +28,6 @@ function p = format(date)
%@eod:
% Copyright (C) 2011 Dynare Team
% stephane DOT adjemian AT univ DASH lemans DOT fr
%
% This file is part of Dynare.
%
@ -45,6 +44,8 @@ function p = format(date)
% You should have received a copy of the GNU General Public License
% along with Dynare. If not, see <http://www.gnu.org/licenses/>.
% Original author: stephane DOT adjemian AT univ DASH lemans DOT fr
if nargin~=1
error('dynDate::format: I need exactly one input argument!')

View File

@ -31,7 +31,6 @@ function c = ge(a,b)
%@eod:
% Copyright (C) 2011 Dynare Team
% stephane DOT adjemian AT univ DASH lemans DOT fr
%
% This file is part of Dynare.
%
@ -48,6 +47,8 @@ function c = ge(a,b)
% You should have received a copy of the GNU General Public License
% along with Dynare. If not, see <http://www.gnu.org/licenses/>.
% Original author: stephane DOT adjemian AT univ DASH lemans DOT fr
if a>b
c=1;
else

View File

@ -30,7 +30,6 @@ function c = gt(a,b)
%@eod:
% Copyright (C) 2011 Dynare Team
% stephane DOT adjemian AT univ DASH lemans DOT fr
%
% This file is part of Dynare.
%
@ -47,6 +46,8 @@ function c = gt(a,b)
% You should have received a copy of the GNU General Public License
% along with Dynare. If not, see <http://www.gnu.org/licenses/>.
% Original author: stephane DOT adjemian AT univ DASH lemans DOT fr
verbose = 0;
if nargin~=2

View File

@ -31,7 +31,6 @@ function c = le(a,b)
%@eod:
% Copyright (C) 2011 Dynare Team
% stephane DOT adjemian AT univ DASH lemans DOT fr
%
% This file is part of Dynare.
%
@ -48,6 +47,8 @@ function c = le(a,b)
% You should have received a copy of the GNU General Public License
% along with Dynare. If not, see <http://www.gnu.org/licenses/>.
% Original author: stephane DOT adjemian AT univ DASH lemans DOT fr
if a<b
c=1;
else

View File

@ -30,7 +30,6 @@ function c = lt(a,b)
%@eod:
% Copyright (C) 2011 Dynare Team
% stephane DOT adjemian AT univ DASH lemans DOT fr
%
% This file is part of Dynare.
%
@ -47,6 +46,8 @@ function c = lt(a,b)
% You should have received a copy of the GNU General Public License
% along with Dynare. If not, see <http://www.gnu.org/licenses/>.
% Original author: stephane DOT adjemian AT univ DASH lemans DOT fr
verbose = 0;
if nargin~=2

View File

@ -30,7 +30,6 @@ function c = max(a,b)
%@eod:
% Copyright (C) 2011 Dynare Team
% stephane DOT adjemian AT univ DASH lemans DOT fr
%
% This file is part of Dynare.
%
@ -47,6 +46,8 @@ function c = max(a,b)
% You should have received a copy of the GNU General Public License
% along with Dynare. If not, see <http://www.gnu.org/licenses/>.
% Original author: stephane DOT adjemian AT univ DASH lemans DOT fr
verbose = 0;
if nargin~=2

View File

@ -30,7 +30,6 @@ function c = min(a,b)
%@eod:
% Copyright (C) 2011 Dynare Team
% stephane DOT adjemian AT univ DASH lemans DOT fr
%
% This file is part of Dynare.
%
@ -47,6 +46,8 @@ function c = min(a,b)
% You should have received a copy of the GNU General Public License
% along with Dynare. If not, see <http://www.gnu.org/licenses/>.
% Original author: stephane DOT adjemian AT univ DASH lemans DOT fr
verbose = 0;
if nargin~=2

View File

@ -32,7 +32,6 @@ function c = minus(a,b)
%@eod:
% Copyright (C) 2011 Dynare Team
% stephane DOT adjemian AT univ DASH lemans DOT fr
%
% This file is part of Dynare.
%
@ -49,6 +48,8 @@ function c = minus(a,b)
% You should have received a copy of the GNU General Public License
% along with Dynare. If not, see <http://www.gnu.org/licenses/>.
% Original author: stephane DOT adjemian AT univ DASH lemans DOT fr
if ~( isa(a,'dynDate') && isa(b,'dynDate') )
error(['dynDate::minus: Input arguments ' inputname(1) ' and ' inputname(2) ' must be dynDate objects!'])
end

View File

@ -30,7 +30,6 @@ function c = ne(a,b)
%@eod:
% Copyright (C) 2011 Dynare Team
% stephane DOT adjemian AT univ DASH lemans DOT fr
%
% This file is part of Dynare.
%
@ -47,6 +46,8 @@ function c = ne(a,b)
% You should have received a copy of the GNU General Public License
% along with Dynare. If not, see <http://www.gnu.org/licenses/>.
% Original author: stephane DOT adjemian AT univ DASH lemans DOT fr
verbose = 0;
if nargin~=2

View File

@ -33,7 +33,6 @@ function B = subsref(A,S)
%@eod:
% Copyright (C) 2011 Dynare Team
% stephane DOT adjemian AT univ DASH lemans DOT fr
%
% This file is part of Dynare.
%
@ -50,4 +49,6 @@ function B = subsref(A,S)
% You should have received a copy of the GNU General Public License
% along with Dynare. If not, see <http://www.gnu.org/licenses/>.
% Original author: stephane DOT adjemian AT univ DASH lemans DOT fr
B = builtin('subsref', A, S);

View File

@ -30,7 +30,6 @@ function b = uminus(a)
%@eod:
% Copyright (C) 2011 Dynare Team
% stephane DOT adjemian AT univ DASH lemans DOT fr
%
% This file is part of Dynare.
%
@ -47,6 +46,8 @@ function b = uminus(a)
% You should have received a copy of the GNU General Public License
% along with Dynare. If not, see <http://www.gnu.org/licenses/>.
% Original author: stephane DOT adjemian AT univ DASH lemans DOT fr
if ~isa(a,'dynDate')
error(['dynDate::uminus: Input argument ' inputname(1) ' must be a dynDate object.'])
end

View File

@ -30,7 +30,6 @@ function b = uplus(a)
%@eod:
% Copyright (C) 2011 Dynare Team
% stephane DOT adjemian AT univ DASH lemans DOT fr
%
% This file is part of Dynare.
%
@ -47,6 +46,8 @@ function b = uplus(a)
% You should have received a copy of the GNU General Public License
% along with Dynare. If not, see <http://www.gnu.org/licenses/>.
% Original author: stephane DOT adjemian AT univ DASH lemans DOT fr
if ~isa(a,'dynDate')
error(['dynDate::uplus: Input argument ' inputname(1) ' must be a dynDate object.'])
end

View File

@ -33,7 +33,6 @@ function B = subsref(A,S)
%@eod:
% Copyright (C) 2011 Dynare Team
% stephane DOT adjemian AT univ DASH lemans DOT fr
%
% This file is part of Dynare.
%
@ -50,6 +49,8 @@ function B = subsref(A,S)
% You should have received a copy of the GNU General Public License
% along with Dynare. If not, see <http://www.gnu.org/licenses/>.
% Original author: stephane DOT adjemian AT univ DASH lemans DOT fr
B = builtin('subsref', A, S);
if isequal(S(1).type,'.')

View File

@ -40,7 +40,6 @@ function a = horzcat(varargin)
%@eod:
% Copyright (C) 2011 Dynare Team
% stephane DOT adjemian AT univ DASH lemans DOT fr
%
% This file is part of Dynare.
%
@ -57,6 +56,8 @@ function a = horzcat(varargin)
% You should have received a copy of the GNU General Public License
% along with Dynare. If not, see <http://www.gnu.org/licenses/>.
% Original author: stephane DOT adjemian AT univ DASH lemans DOT fr
if nargin==0 || nargin==1
error('dynSeries::horzcat: I need at least two input arguments!')
end

View File

@ -42,7 +42,6 @@ function sp = dynTime(a)
%@eod:
% Copyright (C) 2011 Dynare Team
% stephane DOT adjemian AT univ DASH lemans DOT fr
%
% This file is part of Dynare.
%
@ -59,6 +58,8 @@ function sp = dynTime(a)
% You should have received a copy of the GNU General Public License
% along with Dynare. If not, see <http://www.gnu.org/licenses/>.
% Original author: stephane DOT adjemian AT univ DASH lemans DOT fr
sp = struct;
sp.freq = [];

View File

@ -32,7 +32,6 @@ function cprod = cartesian_product_of_sets(varargin)
%@eod:
% Copyright (C) 2011 Dynare Team
% stephane DOT adjemian AT univ DASH lemans DOT fr
%
% This file is part of Dynare.
%
@ -49,6 +48,8 @@ function cprod = cartesian_product_of_sets(varargin)
% You should have received a copy of the GNU General Public License
% along with Dynare. If not, see <http://www.gnu.org/licenses/>.
% Original author: stephane DOT adjemian AT univ DASH lemans DOT fr
[ F{1:nargin} ] = ndgrid( varargin{:} );
for i=1:nargin

View File

@ -32,7 +32,6 @@ function [nodes,weights] = gauss_hermite_weights_and_nodes(n)
%@eod:
% Copyright (C) 2011 Dynare Team
% stephane DOT adjemian AT univ DASH lemans DOT fr
%
% This file is part of Dynare.
%
@ -49,6 +48,8 @@ function [nodes,weights] = gauss_hermite_weights_and_nodes(n)
% You should have received a copy of the GNU General Public License
% along with Dynare. If not, see <http://www.gnu.org/licenses/>.
% Original author: stephane DOT adjemian AT univ DASH lemans DOT fr
b = sqrt([1:n-1]/2);
JacobiMatrix = diag(b,1)+diag(b,-1);
[JacobiEigenVectors,JacobiEigenValues] = eig(JacobiMatrix);

View File

@ -44,7 +44,6 @@ function [D, err] = A_times_B_kronecker_C(A,B,C,fake)
%@eod:
% Copyright (C) 1996-2011 Dynare Team
% stephane DOT adjemian AT univ DASH lemans DOT fr
%
% This file is part of Dynare.
%
@ -61,6 +60,8 @@ function [D, err] = A_times_B_kronecker_C(A,B,C,fake)
% You should have received a copy of the GNU General Public License
% along with Dynare. If not, see <http://www.gnu.org/licenses/>.
% Original author: stephane DOT adjemian AT univ DASH lemans DOT fr
% Chek number of inputs and outputs.
if nargin>4 || nargin<3
error('A_times_B_kronecker_C takes 3 or 4 input arguments and provides 2 output arguments.')

View File

@ -46,7 +46,6 @@ function [D, err] = sparse_hessian_times_B_kronecker_C(varargin)
%@eod:
% Copyright (C) 1996-2011 Dynare Team
% stephane DOT adjemian AT univ DASH lemans DOT fr
%
% This file is part of Dynare.
%
@ -63,6 +62,8 @@ function [D, err] = sparse_hessian_times_B_kronecker_C(varargin)
% You should have received a copy of the GNU General Public License
% along with Dynare. If not, see <http://www.gnu.org/licenses/>.
% Original author: stephane DOT adjemian AT univ DASH lemans DOT fr
A = varargin{1};
B = varargin{2};
C = varargin{3};

View File

@ -35,7 +35,6 @@ function DynareOutput = simul_backward_nonlinear_model(sample_size,DynareOptions
%@eod:
% Copyright (C) 2012 Dynare Team
% stephane DOT adjemian AT univ DASH lemans DOT fr
%
% This file is part of Dynare.
%
@ -52,6 +51,8 @@ function DynareOutput = simul_backward_nonlinear_model(sample_size,DynareOptions
% You should have received a copy of the GNU General Public License
% along with Dynare. If not, see <http://www.gnu.org/licenses/>.
% Original author: stephane DOT adjemian AT univ DASH lemans DOT fr
if DynareModel.maximum_lead
error(['simul_backward_nonlinear_model:: The specified model is not backward looking!'])
end

View File

@ -37,7 +37,6 @@ function dataset_ = compute_acov(dataset_)
%@eod:
% Copyright (C) 2011 Dynare Team
% stephane DOT adjemian AT univ DASH lemans DOT fr
%
% This file is part of Dynare.
%
@ -54,6 +53,8 @@ function dataset_ = compute_acov(dataset_)
% You should have received a copy of the GNU General Public License
% along with Dynare. If not, see <http://www.gnu.org/licenses/>.
% Original author: stephane DOT adjemian AT univ DASH lemans DOT fr
if ~isfield(dataset_.descriptive,'cova')
dataset_ = compute_cova(dataset_);
end

View File

@ -34,7 +34,6 @@ function dataset_ = compute_corr(dataset_)
%@eod:
% Copyright (C) 2011 Dynare Team
% stephane DOT adjemian AT univ DASH lemans DOT fr
%
% This file is part of Dynare.
%
@ -51,6 +50,8 @@ function dataset_ = compute_corr(dataset_)
% You should have received a copy of the GNU General Public License
% along with Dynare. If not, see <http://www.gnu.org/licenses/>.
% Original author: stephane DOT adjemian AT univ DASH lemans DOT fr
if ~isfield(dataset_.descriptive,'cova')
dataset_ = compute_cova(dataset_);
end

View File

@ -31,7 +31,6 @@ function dataset_ = compute_cova(dataset_)
%@eod:
% Copyright (C) 2011 Dynare Team
% stephane DOT adjemian AT univ DASH lemans DOT fr
%
% This file is part of Dynare.
%
@ -48,6 +47,8 @@ function dataset_ = compute_cova(dataset_)
% You should have received a copy of the GNU General Public License
% along with Dynare. If not, see <http://www.gnu.org/licenses/>.
% Original author: stephane DOT adjemian AT univ DASH lemans DOT fr
dataset_.descriptive.cova = zeros(dataset_.nvobs);
data = transpose(dataset_.data);

View File

@ -31,7 +31,6 @@ function dataset_ = compute_stdv(dataset_)
%@eod:
% Copyright (C) 2011 Dynare Team
% stephane DOT adjemian AT univ DASH lemans DOT fr
%
% This file is part of Dynare.
%
@ -48,6 +47,8 @@ function dataset_ = compute_stdv(dataset_)
% You should have received a copy of the GNU General Public License
% along with Dynare. If not, see <http://www.gnu.org/licenses/>.
% Original author: stephane DOT adjemian AT univ DASH lemans DOT fr
if dataset_.missing.state
dataset_.descriptive.stdv = sqrt(nanmean(bsxfun(@power,nandemean(transpose(dataset_.data)),2)));
else

View File

@ -28,7 +28,6 @@ function [i,n,s,j] = describe_missing_data(data)
%@eod:
% Copyright (C) 2008-2011 Dynare Team
% stephane DOT adjemian AT univ DASH lemans DOT fr
%
% This file is part of Dynare.
%
@ -45,6 +44,8 @@ function [i,n,s,j] = describe_missing_data(data)
% You should have received a copy of the GNU General Public License
% along with Dynare. If not, see <http://www.gnu.org/licenses/>.
% Original author: stephane DOT adjemian AT univ DASH lemans DOT fr
[observation_index,variable_index] = find(~isnan(data));
[T,N] = size(data);

View File

@ -46,7 +46,6 @@ function dataset_ = descriptive_statistics(dataset_,statistic,varagin)
%@eod:
% Copyright (C) 2011 Dynare Team
% stephane DOT adjemian AT univ DASH lemans DOT fr
%
% This file is part of Dynare.
%
@ -63,6 +62,8 @@ function dataset_ = descriptive_statistics(dataset_,statistic,varagin)
% You should have received a copy of the GNU General Public License
% along with Dynare. If not, see <http://www.gnu.org/licenses/>.
% Original author: stephane DOT adjemian AT univ DASH lemans DOT fr
if strcmpi(statistic,'stdv')
dataset_ = compute_std(dataset_)

View File

@ -2,7 +2,6 @@ function dataset_ = initialize_dataset(datafile,varobs,first,nobs,transformation
% Initializes a structure describing the dataset.
% Copyright (C) 2011 Dynare Team
% stephane DOT adjemian AT univ DASH lemans DOT fr
%
% This file is part of Dynare.
%
@ -19,6 +18,8 @@ function dataset_ = initialize_dataset(datafile,varobs,first,nobs,transformation
% You should have received a copy of the GNU General Public License
% along with Dynare. If not, see <http://www.gnu.org/licenses/>.
% Original author: stephane DOT adjemian AT univ DASH lemans DOT fr
if isempty(datafile)
error('Estimation:: You have to declare a dataset file!')
end

View File

@ -32,7 +32,6 @@ function dynInfo(fun)
%@eod:
% Copyright (C) 2011 Dynare Team
% stephane DOT adjemian AT univ DASH lemans DOT fr
%
% This file is part of Dynare.
%
@ -49,6 +48,8 @@ function dynInfo(fun)
% You should have received a copy of the GNU General Public License
% along with Dynare. If not, see <http://www.gnu.org/licenses/>.
% Original author: stephane DOT adjemian AT univ DASH lemans DOT fr
if isempty(strfind(fun,'@')) & (~isempty(strfind(fun,'/')) || ~isempty(strfind(fun,'\')) )
[pathstr1, name, ext] = fileparts(fun);
addpath(pathstr1);

View File

@ -2,7 +2,6 @@ function block = get_internal_doc_block(fname,fpath)
% Extract doc sections from matlab's routine.
% Copyright (C) 2011 Dynare Team
% stephane DOT adjemian AT univ DASH lemans DOT fr
%
% This file is part of Dynare.
%
@ -19,6 +18,8 @@ function block = get_internal_doc_block(fname,fpath)
% You should have received a copy of the GNU General Public License
% along with Dynare. If not, see <http://www.gnu.org/licenses/>.
% Original author: stephane DOT adjemian AT univ DASH lemans DOT fr
% Default output
block = [];

View File

@ -28,7 +28,6 @@ function c = demean(x)
%@eod:
% Copyright (C) 2011 Dynare Team
% stephane DOT adjemian AT ens DOT fr
%
% This file is part of Dynare.
%
@ -44,6 +43,8 @@ function c = demean(x)
%
% You should have received a copy of the GNU General Public License
% along with Dynare. If not, see <http://www.gnu.org/licenses/>.
% Original author: stephane DOT adjemian AT univ DASH lemans DOT fr
if ndim(x)==1
c = x-mean(x);

View File

@ -28,7 +28,6 @@ function a = isfile(b)
%@eod:
% Copyright (C) 2012 Dynare Team
% stephane DOT adjemian AT ens DOT fr
%
% This file is part of Dynare.
%
@ -45,6 +44,8 @@ function a = isfile(b)
% You should have received a copy of the GNU General Public License
% along with Dynare. If not, see <http://www.gnu.org/licenses/>.
% Original author: stephane DOT adjemian AT univ DASH lemans DOT fr
[base,ext] = strtok(b,'.');
if isempty(ext)

View File

@ -28,7 +28,6 @@ function n = ndim(x)
%@eod:
% Copyright (C) 2011 Dynare Team
% stephane DOT adjemian AT ens DOT fr
%
% This file is part of Dynare.
%
@ -45,4 +44,6 @@ function n = ndim(x)
% You should have received a copy of the GNU General Public License
% along with Dynare. If not, see <http://www.gnu.org/licenses/>.
% Original author: stephane DOT adjemian AT univ DASH lemans DOT fr
n = sum(size(x)>1);

View File

@ -33,7 +33,6 @@ function dynTest(fun,dynare_path)
%@eod:
% Copyright (C) 2011-2012 Dynare Team
% stephane DOT adjemian AT univ DASH lemans DOT fr
%
% This file is part of Dynare.
%
@ -50,6 +49,8 @@ function dynTest(fun,dynare_path)
% You should have received a copy of the GNU General Public License
% along with Dynare. If not, see <http://www.gnu.org/licenses/>.
% Original author: stephane DOT adjemian AT univ DASH lemans DOT fr
original_directory = pwd();
[pathstr1, name1, ext1] = fileparts(fun);

View File

@ -2,7 +2,6 @@ function t = dyn_assert(A,B,tol)
% This function tests the equality of two objects.
% Copyright (C) 2011 Dynare Team
% stephane DOT adjemian AT univ DASH lemans DOT fr
%
% This file is part of Dynare.
%
@ -19,6 +18,8 @@ function t = dyn_assert(A,B,tol)
% You should have received a copy of the GNU General Public License
% along with Dynare. If not, see <http://www.gnu.org/licenses/>.
% Original author: stephane DOT adjemian AT univ DASH lemans DOT fr
if ( (nargin<3) || isempty(tol) )
use_isequal_matlab_builtin = 1;
else

View File

@ -2,7 +2,6 @@ function check = mtest(fname,fpath)
% Extract test sections from matlab's routine executes the test and report errors.
% Copyright (C) 2011 Dynare Team
% stephane DOT adjemian AT univ DASH lemans DOT fr
%
% This file is part of Dynare.
%
@ -19,6 +18,8 @@ function check = mtest(fname,fpath)
% You should have received a copy of the GNU General Public License
% along with Dynare. If not, see <http://www.gnu.org/licenses/>.
% Original author: stephane DOT adjemian AT univ DASH lemans DOT fr
% Default answer (no problem).
check = 1;

View File

@ -1,7 +1,6 @@
% matlab script for testing matlab routines.
% Copyright (C) 2011 Dynare Team
% stephane DOT adjemian AT ens DOT fr
%
% This file is part of Dynare.
%
@ -18,6 +17,8 @@
% You should have received a copy of the GNU General Public License
% along with Dynare. If not, see <http://www.gnu.org/licenses/>.
% Original author: stephane DOT adjemian AT univ DASH lemans DOT fr
list_of_routines = cell(1);
list_of_routines(1,1) = {'../../matlab/@dynSeries'}; % path