From c5da6de388c83f5646255bb25273efee5fe23eb1 Mon Sep 17 00:00:00 2001 From: Houtan Bastani Date: Mon, 10 Jun 2013 14:51:00 +0200 Subject: [PATCH 01/11] doc: dynDate, dynDates, dynSeries (first draft) --- doc/dynare.texi | 110 ++++++++++++++++++++++++++++++++++++++++++++++++ 1 file changed, 110 insertions(+) diff --git a/doc/dynare.texi b/doc/dynare.texi index a7d2a5ff2..58a49f0c9 100644 --- a/doc/dynare.texi +++ b/doc/dynare.texi @@ -105,6 +105,7 @@ This is Dynare Reference Manual, version @value{VERSION}. * Running Dynare:: * The Model file:: * The Configuration File:: +* Time Series:: * Reporting:: * Examples:: * Dynare internal documentation and unitary tests:: @@ -7870,6 +7871,115 @@ MatlabOctavePath = matlab @end deffn +@node Time Series +@chapter Time Series + +Dynare provides a Matlab class for handling time series data, which is +based on classes for handling dates. Below, you will first find the +classes and methods used for creating and dealing with dates and then +the class used for using time series. + +@section dynDate + +@deftypefn {dynDate} dynDate (@code{INTEGER}) +@deftypefnx {dynDate} dynDate (@code{STRING}) +@deftypefnx {dynDate} dynDate (@var{NUMERICAL_VECTOR}, @code{INTEGER}) +Returns a @code{dynDate} object that represents a date. + +If the value passed is an @code{INTEGER}, return a date of annual +frequency. + +If the value passed is a @code{STRING}, you can declare an empty or +non-empty @code{dynDate} object. If instantiating an empty +@code{dynDate} object, the argument can take one of the following +values representing its frequency: @code{`Y'}, @code{`Q'}, @code{`M'}, +or @code{`W'}. If creating a date with a value, it should be passed in +one of the following formats: @code{`1999'} for an annual date, +@code{`1999q4'} for a quarterly date, @code{`1999m12'} for a monthly +date, and @code{`1999w52'} for a weekly date. + +If the value passed is a @code{NUMERICAL_VECTOR} it should be a vector +of size @code{2}. The format should be: @code{[year period]}. In this +case, you must pass a second argument to the @code{dynDate} consructor +indicating the freqency of the date as an @code{INTEGER}. This +argument can take the following possible values: @code{1} for annual, +@code{4} for quarterly, @code{12} for monthly and @code{52} for +weekly. + +@examplehead + +An example of various ways to create a @code{dynDate} object: + +@example +do1 = dynDate(`1999'); % 1999 +do2 = dynDate(`Q'); % NaNqNan +do3 = dynDate([1999 2], 12); % 1999m2 +@end example +@end deftypefn + + +@section dynDates + +@deftypefn {dynDates} dynDates (@code{STRING} [, @code{STRING} @dots{}]) +Returns a @code{dynDates} object that represents a list of dates. + +Providing a @code{STRING} argument populates the object with the date +represented by said @code{STRING}. If more than one argument is +provided, they should all be dates represented as @code{STRINGS}. + +@examplehead + +An example of various ways to create a @code{dynDates} object: + +@example +do1 = dynDates(`1999', `2000', `2001', `2002'); +do2 = dynDates(`1999', `2003', `2002'); +do3 = dynDate(`1999Q2'):dynDate(`2000Q3'); +@end example +Here, @code{do1} and @code{do2} contain the dates specified in the +order specified. @code{do3} contains a quarterly list of all dates +between @code{1999q2} and @code{2000q3} inclusive. +@end deftypefn + +@section dynSeries + +@deftypefn {dynSeries} dynSeries (@code{dynDate}) +@deftypefnx {dynSeries} dynSeries (@code{FILENAME}) +@deftypefnx {dynSeries} dynSeries (@code{DOUBLE_MATRIX}, @code{dynDate}, @code{CELLSTR}, @code{CELLSTR}) +@deftypefnx {dynSeries} dynSeries (@code{DOUBLE_MATRIX}, @code{STRING}, @code{CELLSTR}, @code{CELLSTR}) +Returns a @code{dynSeries} object that represents one or more time +series. + +If a @code{dynDate} argument is provided, instantiate an empty +@code{dynSeries} with an inital date equal to the input argument. + +If a @code{FILENAME} is passed as input, a @code{dynSeries} object +will be created from the named file. Valid file types are @file{.m} +file, @file{.mat} file, and @file{.csv}. + +If the data is not read from a file, it can be provided via a +@math{T}x@math{N} matrix as the first argument to @code{dynSeries}, with +@math{T} representing the number of observations on @math{N} +variables. The second argument in such a calling sequence can be +either a @code{dynDate} representing the period of the first +observation or a @code{STRING} which would be used to instantiate a +@code{dynDate}. The third argument is a @code{CELLSTR} of size +@math{N} with one entry for each variable name. The final argument is +a @code{CELLSTR} of size @math{N} composed of the @LaTeX{} names +associated with the variables. Input arguments three and four are +optional. + +@examplehead + +An example of various ways to create a @code{dynSeries} object: + +@example +do1 = dynSeries(dynDate(1999)); +do2 = dynSeries(`filename.csv'); +do3 = dynSeries([1; 2; 3], dynDate(1999), @{`var123'@}, @{`var_@{123@}'@}); +@end example +@end deftypefn + @node Reporting @chapter Reporting From 17b034584e73adf2165cf608d87649dc10a8030d Mon Sep 17 00:00:00 2001 From: Houtan Bastani Date: Tue, 11 Jun 2013 12:55:42 +0200 Subject: [PATCH 02/11] doc: update reporting --- doc/dynare.texi | 13 ++++++------- 1 file changed, 6 insertions(+), 7 deletions(-) diff --git a/doc/dynare.texi b/doc/dynare.texi index 58a49f0c9..1460e6bd0 100644 --- a/doc/dynare.texi +++ b/doc/dynare.texi @@ -8141,9 +8141,9 @@ The names of the series contained in the @code{dynSeries} provided to the @ref{data} option. If empty, use all series provided to @ref{data} option. Default: @code{empty} -@item shade, @code{dynDate}:@code{dynDate} -A @code{dynDates} range showing the portion of the graph that should -be shaded. Default: @code{none} +@item shade, @code{dynDates} +The date range showing the portion of the graph that should be +shaded. Default: @code{none} @item shadeColor, @code{MATLAB_COLOR_NAME} The color to use in the shaded portion of the graph. Default: @@ -8161,9 +8161,8 @@ The x-axis label. Default: @code{none} @item ylabel, @code{STRING} The y-axis label. Default: @code{none} -@item xrange, @code{dynDate}:@code{dynDate} -The boundary on the x-axis to display in the graph, represented as a -@code{dynDate} range. Default: all +@item xrange, @code{dynDates} +The boundary on the x-axis to display in the graph. Default: all @item yrange, @code{dynDate}:@code{dynDate} The boundary on the y-axis to display in the graph, represented as a @@ -8189,7 +8188,7 @@ Whether or not to show horizontal lines separating the rows. Default: @code{fals @item precision, @code{INTEGER} The number of decimal places to report in the table data. Default: @code{1} -@item range, @code{dynDate}:@code{dynDate} +@item range, @code{dynDates} The date range of the data to be displayed. Default: @code{all} @item seriesToUse, @code{CELL_ARRAY_STRINGS} From 6ff4d5cce77a8350ef8b528f90d6b6c8e4589100 Mon Sep 17 00:00:00 2001 From: Houtan Bastani Date: Tue, 11 Jun 2013 12:57:44 +0200 Subject: [PATCH 03/11] doc: fix bug in reporting --- doc/dynare.texi | 5 +++-- 1 file changed, 3 insertions(+), 2 deletions(-) diff --git a/doc/dynare.texi b/doc/dynare.texi index 1460e6bd0..dcb8d1b3f 100644 --- a/doc/dynare.texi +++ b/doc/dynare.texi @@ -8164,9 +8164,10 @@ The y-axis label. Default: @code{none} @item xrange, @code{dynDates} The boundary on the x-axis to display in the graph. Default: all -@item yrange, @code{dynDate}:@code{dynDate} +@item yrange, @code{NUMERICAL_VECTOR} The boundary on the y-axis to display in the graph, represented as a -@code{dynDate} range. Default: all +@code{NUMERICAL_VECTOR} of size @math{2}, with the first entry less +than the second entry. Default: all @item showZeroline, @code{BOOLEAN} Display a solid black line at @math{y = 0}. Default: @code{false} From 58a583c2487a91e2e045eb64e1929236518b1263 Mon Sep 17 00:00:00 2001 From: Houtan Bastani Date: Tue, 11 Jun 2013 17:11:15 +0200 Subject: [PATCH 04/11] reporting: fix echo command in system searches for pdflatex --- matlab/reports/@report/compile.m | 16 +++++++++------- 1 file changed, 9 insertions(+), 7 deletions(-) mode change 100644 => 100755 matlab/reports/@report/compile.m diff --git a/matlab/reports/@report/compile.m b/matlab/reports/@report/compile.m old mode 100644 new mode 100755 index 421a8fedd..5547ac2a2 --- a/matlab/reports/@report/compile.m +++ b/matlab/reports/@report/compile.m @@ -46,18 +46,24 @@ if ~exist(o.filename, 'file') o.write(); end +middle = './'; +if exist('OCTAVE_VERSION') + echo = 0; +else + echo = '-echo'; +end if isempty(compiler) if strncmp(computer, 'MACI', 4) || ~isempty(regexpi(computer, '.*apple.*', 'once')) % Add most likely places for pdflatex to exist outside of default $PATH [status, compiler] = ... system(['PATH=$PATH:/usr/texbin:/usr/local/bin:/usr/local/sbin;' ... - 'which pdflatex'], '-echo'); + 'which pdflatex'], echo); elseif strcmp(computer, 'PCWIN') || strcmp(computer, 'PCWIN64') error(['@report.compile: On Windows machines, you must explicitly ' ... 'provide the ''compiler'' option or set the compiler ' ... 'variable in the Report class']); else % gnu/linux - [status, compiler] = system('which pdflatex', '-echo'); + [status, compiler] = system('which pdflatex', echo); end assert(status == 0, ... '@report.compile: Could not find a tex compiler on your system'); @@ -65,11 +71,7 @@ if isempty(compiler) o.compiler = compiler; end -if exist('OCTAVE_VERSION') - status = system([compiler ' ./' o.filename], 0); -else - status = system([compiler ' ./' o.filename], '-echo'); -end +status = system([compiler middle o.filename], echo); [junk, rfn, junk] = fileparts(o.filename); if status ~= 0 From dec9c3a315eb344460295df456820781fc96c8dd Mon Sep 17 00:00:00 2001 From: Houtan Bastani Date: Tue, 11 Jun 2013 17:11:48 +0200 Subject: [PATCH 05/11] reporting: search for pdflatex.exe on windows --- matlab/reports/@report/compile.m | 6 +++--- 1 file changed, 3 insertions(+), 3 deletions(-) diff --git a/matlab/reports/@report/compile.m b/matlab/reports/@report/compile.m index 5547ac2a2..60ba0c4d0 100755 --- a/matlab/reports/@report/compile.m +++ b/matlab/reports/@report/compile.m @@ -59,9 +59,9 @@ if isempty(compiler) system(['PATH=$PATH:/usr/texbin:/usr/local/bin:/usr/local/sbin;' ... 'which pdflatex'], echo); elseif strcmp(computer, 'PCWIN') || strcmp(computer, 'PCWIN64') - error(['@report.compile: On Windows machines, you must explicitly ' ... - 'provide the ''compiler'' option or set the compiler ' ... - 'variable in the Report class']); + [status, compiler] = system('findtexmf --file-type=exe pdflatex', echo); + middle = ' '; + compiler = ['"' strtrim(compiler) '"']; else % gnu/linux [status, compiler] = system('which pdflatex', echo); end From 1a6f8753d17b0d7e0c16971d47d0b34294b923b9 Mon Sep 17 00:00:00 2001 From: Houtan Bastani Date: Tue, 11 Jun 2013 17:12:16 +0200 Subject: [PATCH 06/11] reporting: in windows, replace native filesep with forward slash for inclusion in tex file --- matlab/reports/@graph/createGraph.m | 6 +++++- 1 file changed, 5 insertions(+), 1 deletion(-) mode change 100644 => 100755 matlab/reports/@graph/createGraph.m diff --git a/matlab/reports/@graph/createGraph.m b/matlab/reports/@graph/createGraph.m old mode 100644 new mode 100755 index 6979f67f1..69e73c4f1 --- a/matlab/reports/@graph/createGraph.m +++ b/matlab/reports/@graph/createGraph.m @@ -127,7 +127,11 @@ end drawnow; if isempty(o.figname) - o.figname = [tempname '.tex']; + tn = tempname; + if strcmp(computer, 'PCWIN') || strcmp(computer, 'PCWIN64') + tn = strrep(tn, '\', '/'); + end + o.figname = [tn '.tex']; end disp(' converting to tex....'); if exist('OCTAVE_VERSION') && isempty(regexpi(computer, '.*apple.*', 'once')) From 42bf69473faed12f5c4266f7749e3a15b6b39ec0 Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?S=C3=A9bastien=20Villemot?= Date: Tue, 11 Jun 2013 16:53:55 +0200 Subject: [PATCH 07/11] Minor cleanups to ref. manual --- doc/dynare.texi | 9 +++------ 1 file changed, 3 insertions(+), 6 deletions(-) diff --git a/doc/dynare.texi b/doc/dynare.texi index dcb8d1b3f..3c7ef9180 100644 --- a/doc/dynare.texi +++ b/doc/dynare.texi @@ -798,10 +798,6 @@ during the computation. Structure containing the various results of the computations. @end defvr -@menu -* Understanding Preprocessor Error Messages:: -@end menu - @node Understanding Preprocessor Error Messages @section Understanding Preprocessor Error Messages @@ -4189,7 +4185,8 @@ the file @anchor{nobs1} Runs a recursive estimation and forecast for samples of size ranging of @var{INTEGER1} to @var{INTEGER2}. Option @code{forecast} must -also be specified. The forecasts are stored in the @code{RecursiveForecast} field of the results structure. @xref{RecursiveForecast} +also be specified. The forecasts are stored in the +@code{RecursiveForecast} field of the results structure (@pxref{RecursiveForecast}). @item first_obs = @var{INTEGER} @anchor{first_obs} @@ -4948,7 +4945,7 @@ Variable set by the @code{estimation} command. Stores log-posterior of final MCM @defvr {MATLAB/Octave variable} oo_.RecursiveForecast @anchor{RecursiveForecast} -Variable set by the @code{forecast} option of the @code{estimation} command when used with the nobs = [@var{INTEGER1}:@var{INTEGER2}] option (@xref{nobs1,,nobs}). +Variable set by the @code{forecast} option of the @code{estimation} command when used with the nobs = [@var{INTEGER1}:@var{INTEGER2}] option (@pxref{nobs1,,nobs}). Fields are of the form: @example From 7c5936549f0880af08fb5bc210d55cc951a1bbfa Mon Sep 17 00:00:00 2001 From: Houtan Bastani Date: Wed, 12 Jun 2013 15:01:51 +0200 Subject: [PATCH 08/11] doc: dynDate: remove documentation about empty date (functionality in code to be removed at a later date). --- doc/dynare.texi | 8 ++------ 1 file changed, 2 insertions(+), 6 deletions(-) diff --git a/doc/dynare.texi b/doc/dynare.texi index 3c7ef9180..16f64f163 100644 --- a/doc/dynare.texi +++ b/doc/dynare.texi @@ -7886,12 +7886,8 @@ Returns a @code{dynDate} object that represents a date. If the value passed is an @code{INTEGER}, return a date of annual frequency. -If the value passed is a @code{STRING}, you can declare an empty or -non-empty @code{dynDate} object. If instantiating an empty -@code{dynDate} object, the argument can take one of the following -values representing its frequency: @code{`Y'}, @code{`Q'}, @code{`M'}, -or @code{`W'}. If creating a date with a value, it should be passed in -one of the following formats: @code{`1999'} for an annual date, +If the value passed is a @code{STRING}, it should be passed in one of +the following formats: @code{`1999'} for an annual date, @code{`1999q4'} for a quarterly date, @code{`1999m12'} for a monthly date, and @code{`1999w52'} for a weekly date. From 555fc986738b6cfb897aefd825f28aa4fedbf587 Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?S=C3=A9bastien=20Villemot?= Date: Wed, 12 Jun 2013 15:16:38 +0200 Subject: [PATCH 09/11] Fix bug in gemv binding --- mex/sources/estimation/libmat/BlasBindings.hh | 17 ++++++++++------- 1 file changed, 10 insertions(+), 7 deletions(-) diff --git a/mex/sources/estimation/libmat/BlasBindings.hh b/mex/sources/estimation/libmat/BlasBindings.hh index 50b246021..d4b67ca55 100644 --- a/mex/sources/estimation/libmat/BlasBindings.hh +++ b/mex/sources/estimation/libmat/BlasBindings.hh @@ -1,5 +1,5 @@ /* - * Copyright (C) 2010-2011 Dynare Team + * Copyright (C) 2010-2013 Dynare Team * * This file is part of Dynare. * @@ -63,16 +63,19 @@ namespace blas gemv(const char *transa, double alpha, const Mat1 &A, const Vec2 &B, double beta, Vec3 &C) { - blas_int m = A.getRows(), n = B.getSize(), k = A.getCols(), l = C.getSize(); + blas_int m = A.getRows(), n = A.getCols(); if (*transa == 'T') { - m = A.getCols(); - k = A.getRows(); + assert(C.getSize() == A.getCols()); + assert(B.getSize() == A.getRows()); + } + else + { + assert(C.getSize() == A.getRows()); + assert(B.getSize() == A.getCols()); } - assert(m == l); - assert(k == n); blas_int lda = A.getLd(), ldb = B.getStride(), ldc = C.getStride(); - dgemv(transa, &m, &n, &alpha, A.getData(), &lda, + dgemv(transa, &m, &n, &alpha, A.getData(), &lda, B.getData(), &ldb, &beta, C.getData(), &ldc); } From f1c8ec60c7f52f34c69b9b8fb428802a99f3b451 Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?S=C3=A9bastien=20Villemot?= Date: Wed, 12 Jun 2013 16:05:10 +0200 Subject: [PATCH 10/11] Remove various compilation warnings --- .../block_kalman_filter.cc | 2 +- mex/sources/bytecode/ErrorHandling.hh | 2 +- mex/sources/bytecode/Evaluate.cc | 1 - mex/sources/bytecode/Interpreter.cc | 4 --- mex/sources/bytecode/SparseMatrix.cc | 18 ++++++------ mex/sources/bytecode/bytecode.cc | 28 +++++++++---------- mex/sources/estimation/KalmanFilter.hh | 2 -- mex/sources/estimation/Prior.cc | 4 ++- mex/sources/estimation/logMHMCMCposterior.cc | 3 +- mex/sources/estimation/logposterior.cc | 2 -- .../k_order_perturbation/k_ord_dynare.cc | 10 +++---- .../kalman_steady_state.cc | 8 +++--- .../local_state_space_iteration_2.cc | 8 +++--- 13 files changed, 42 insertions(+), 50 deletions(-) diff --git a/mex/sources/block_kalman_filter/block_kalman_filter.cc b/mex/sources/block_kalman_filter/block_kalman_filter.cc index 0c44b0b6a..e8741cf66 100644 --- a/mex/sources/block_kalman_filter/block_kalman_filter.cc +++ b/mex/sources/block_kalman_filter/block_kalman_filter.cc @@ -289,7 +289,7 @@ BlockKalmanFilter::BlockKalmanFilter(int nlhs, mxArray *plhs[], int nrhs, const iw = (lapack_int*)mxMalloc(pp * sizeof(lapack_int)); ipiv = (lapack_int*)mxMalloc(pp * sizeof(lapack_int)); info = 0; -#ifdef BLAS || CUBLAS +#if defined(BLAS) || defined(CUBLAS) p_tmp = mxCreateDoubleMatrix(n, n, mxREAL); *tmp = mxGetPr(p_tmp); p_P_t_t1 = mxCreateDoubleMatrix(n, n, mxREAL); diff --git a/mex/sources/bytecode/ErrorHandling.hh b/mex/sources/bytecode/ErrorHandling.hh index b89fc88f2..d7759de51 100644 --- a/mex/sources/bytecode/ErrorHandling.hh +++ b/mex/sources/bytecode/ErrorHandling.hh @@ -381,7 +381,7 @@ public: size_t n = Variable_list.size(); int i = 0; bool notfound = true; - while (notfound && i < n) + while (notfound && i < (int) n) { if (variable_name == Variable_list[i].first) { diff --git a/mex/sources/bytecode/Evaluate.cc b/mex/sources/bytecode/Evaluate.cc index 68d3172c9..b53dc12f9 100644 --- a/mex/sources/bytecode/Evaluate.cc +++ b/mex/sources/bytecode/Evaluate.cc @@ -1608,7 +1608,6 @@ Evaluate::evaluate_complete(const bool no_derivatives) void Evaluate::compute_complete_2b(const bool no_derivatives, double *_res1, double *_res2, double *_max_res, int *_max_res_idx) { - bool result; res1 = 0; *_res1 = 0; *_res2 = 0; diff --git a/mex/sources/bytecode/Interpreter.cc b/mex/sources/bytecode/Interpreter.cc index 2e3f8690b..91aeffdfc 100644 --- a/mex/sources/bytecode/Interpreter.cc +++ b/mex/sources/bytecode/Interpreter.cc @@ -487,8 +487,6 @@ Interpreter::simulate_a_block() res1 = 0; max_res = 0; max_res_idx = 0; - double res1_, res2_, max_res_; - int max_res_idx_; memcpy(y_save, y, y_size*sizeof(double)*(periods+y_kmax+y_kmin)); compute_complete_2b(false, &res1, &res2, &max_res, &max_res_idx); @@ -523,8 +521,6 @@ Interpreter::simulate_a_block() res1 = 0; res2 = 0; max_res = 0; max_res_idx = 0; - double res1_, res2_, max_res_; - int max_res_idx_; compute_complete_2b(false, &res1, &res2, &max_res, &max_res_idx); end_code = it_code; diff --git a/mex/sources/bytecode/SparseMatrix.cc b/mex/sources/bytecode/SparseMatrix.cc index f68864e37..c0bd86f73 100644 --- a/mex/sources/bytecode/SparseMatrix.cc +++ b/mex/sources/bytecode/SparseMatrix.cc @@ -1568,7 +1568,7 @@ PrintM(int n, double* Ax, mwIndex *Ap, mwIndex *Ai) int k = 0; for (int i = 0; i< n; i++) { - for (int j = Ap[i]; j < Ap[i + 1]; j++) + for (int j = Ap[i]; j < (int) Ap[i + 1]; j++) { int row = Ai[j]; A[row *n + i] = Ax[j]; @@ -2430,7 +2430,7 @@ dynSparseMatrix::substract_A_B(mxArray *A_m, mxArray *B_m) #ifdef USE_OMP #pragma omp parallel for num_threads(atoi(getenv("DYNARE_NUM_THREADS"))) #endif - for (int j = 0; j < n_A; j++) + for (int j = 0; j < (int) n_A; j++) for (unsigned int i = 0; i < m_A; i++) { size_t index = j*m_A+i; @@ -3157,7 +3157,7 @@ dynSparseMatrix::Solve_Matlab_LU_UMFPack(mxArray *A_m, mxArray *b_m, int Size, d #ifdef USE_OMP #pragma omp parallel for num_threads(atoi(getenv("DYNARE_NUM_THREADS"))) #endif - for (int i = 0; i < n; i++) + for (int i = 0; i < (int) n; i++) { int eq = index_vara[i+Size*y_kmin]; double yy = -(res[i] + y[eq]); @@ -3168,7 +3168,7 @@ dynSparseMatrix::Solve_Matlab_LU_UMFPack(mxArray *A_m, mxArray *b_m, int Size, d #ifdef USE_OMP #pragma omp parallel for num_threads(atoi(getenv("DYNARE_NUM_THREADS"))) #endif - for (int i = 0; i < n; i++) + for (int i = 0; i < (int) n; i++) { int eq = index_vara[i]; double yy = -(res[i] + y[eq+it_*y_size]); @@ -4073,7 +4073,7 @@ dynSparseMatrix::Solve_CUDA_BiCGStab(int *Ap, int *Ai, double *Ax, int *Ap_tild, mexWarnMsgTxt(tmp.str().c_str()); return 4;*/ - /* /**Apply the permutation matrices (P and Q) to the b vector of system to solve : + /* Apply the permutation matrices (P and Q) to the b vector of system to solve : b_tild = P-1 . b = P' . b */ /*cudaChk(cudaMalloc((void**)&b_tild, n * sizeof(double)), " in Solve_Cuda_BiCGStab, can't allocate b_tild on the graphic card\n"); cusparseChk(cusparseDcsrmv(cusparse_handle, CUSPARSE_OPERATION_TRANSPOSE, @@ -4661,7 +4661,7 @@ dynSparseMatrix::Solve_Matlab_GMRES(mxArray *A_m, mxArray *b_m, int Size, double #ifdef USE_OMP #pragma omp parallel for num_threads(atoi(getenv("DYNARE_NUM_THREADS"))) #endif - for (int i = 0; i < n; i++) + for (int i = 0; i < (int) n; i++) { int eq = index_vara[i+Size*y_kmin]; double yy = -(res[i] + y[eq]); @@ -4672,7 +4672,7 @@ dynSparseMatrix::Solve_Matlab_GMRES(mxArray *A_m, mxArray *b_m, int Size, double #ifdef USE_OMP #pragma omp parallel for num_threads(atoi(getenv("DYNARE_NUM_THREADS"))) #endif - for (int i = 0; i < n; i++) + for (int i = 0; i < (int) n; i++) { int eq = index_vara[i]; double yy = -(res[i] + y[eq+it_*y_size]); @@ -4870,7 +4870,7 @@ dynSparseMatrix::Solve_Matlab_BiCGStab(mxArray *A_m, mxArray *b_m, int Size, dou #ifdef USE_OMP #pragma omp parallel for num_threads(atoi(getenv("DYNARE_NUM_THREADS"))) #endif - for (int i = 0; i < n; i++) + for (int i = 0; i < (int) n; i++) { int eq = index_vara[i+Size*y_kmin]; double yy = -(res[i] + y[eq]); @@ -4881,7 +4881,7 @@ dynSparseMatrix::Solve_Matlab_BiCGStab(mxArray *A_m, mxArray *b_m, int Size, dou #ifdef USE_OMP #pragma omp parallel for num_threads(atoi(getenv("DYNARE_NUM_THREADS"))) #endif - for (int i = 0; i < n; i++) + for (int i = 0; i < (int) n; i++) { int eq = index_vara[i]; double yy = -(res[i] + y[eq+it_*y_size]); diff --git a/mex/sources/bytecode/bytecode.cc b/mex/sources/bytecode/bytecode.cc index 3dde9e031..c56f97b9c 100644 --- a/mex/sources/bytecode/bytecode.cc +++ b/mex/sources/bytecode/bytecode.cc @@ -224,7 +224,7 @@ GPU_close(cublasHandle_t cublas_handle, cusparseHandle_t cusparse_handle, cuspar string deblank(string x) { - for(int i = 0; i < x.length(); i++) + for(int i = 0; i < (int) x.length(); i++) if (x[i] == ' ') x.erase(i--, 1); return x; @@ -316,28 +316,28 @@ Get_Arguments_and_global_variables(int nrhs, else { ; - if ((pos = Get_Argument(prhs[i]).find("block")) != (int) string::npos) + if ((pos = Get_Argument(prhs[i]).find("block")) != string::npos) { size_t pos1 = Get_Argument(prhs[i]).find("=", pos+5); - if (pos1 != (int) string::npos) + if (pos1 != string::npos) pos = pos1 + 1; else pos += 5; block = atoi(Get_Argument(prhs[i]).substr(pos, string::npos).c_str())-1; } - else if ((pos = Get_Argument(prhs[i]).find("pfplan")) != (int) string::npos) + else if ((pos = Get_Argument(prhs[i]).find("pfplan")) != string::npos) { size_t pos1 = Get_Argument(prhs[i]).find("=", pos+6); - if (pos1 != (int) string::npos) + if (pos1 != string::npos) pos = pos1 + 1; else pos += 6; *pfplan_struct_name = deblank(Get_Argument(prhs[i]).substr(pos, string::npos)); } - else if ((pos = Get_Argument(prhs[i]).find("plan")) != (int) string::npos) + else if ((pos = Get_Argument(prhs[i]).find("plan")) != string::npos) { size_t pos1 = Get_Argument(prhs[i]).find("=", pos+4); - if (pos1 != (int) string::npos) + if (pos1 != string::npos) pos = pos1 + 1; else pos += 4; @@ -405,7 +405,7 @@ main(int nrhs, const char *prhs[]) char *plhs[1]; load_global((char *) prhs[1]); #endif - mxArray *plan_struct = NULL, *pfplan_struct = NULL; + mxArray *pfplan_struct = NULL; size_t i, row_y = 0, col_y = 0, row_x = 0, col_x = 0, nb_row_xd = 0; size_t steady_row_y, steady_col_y; int y_kmin = 0, y_kmax = 0, y_decal = 0; @@ -473,7 +473,7 @@ main(int nrhs, const char *prhs[]) } size_t n_plan = mxGetN(plan_struct); splan.resize(n_plan); - for (int i = 0; i < n_plan; i++) + for (int i = 0; i < (int) n_plan; i++) { splan[i].var = ""; splan[i].exo = ""; @@ -519,11 +519,11 @@ main(int nrhs, const char *prhs[]) size_t num_shocks = mxGetM(tmp); (splan[i]).per_value.resize(num_shocks); double * per_value = mxGetPr(tmp); - for (int j = 0; j < num_shocks; j++) + for (int j = 0; j < (int) num_shocks; j++) (splan[i]).per_value[j] = make_pair(ceil(per_value[j]), per_value[j + num_shocks]); } } - int i; + int i = 0; for (vector::iterator it = splan.begin(); it != splan.end(); it++) { mexPrintf("----------------------------------------------------------------------------------------------------\n"); @@ -551,7 +551,7 @@ main(int nrhs, const char *prhs[]) } size_t n_plan = mxGetN(pfplan_struct); spfplan.resize(n_plan); - for (int i = 0; i < n_plan; i++) + for (int i = 0; i < (int) n_plan; i++) { spfplan[i].var = ""; spfplan[i].exo = ""; @@ -597,11 +597,11 @@ main(int nrhs, const char *prhs[]) size_t num_shocks = mxGetM(tmp); double * per_value = mxGetPr(tmp); (spfplan[i]).per_value.resize(num_shocks); - for (int j = 0; j < num_shocks; j++) + for (int j = 0; j < (int) num_shocks; j++) spfplan[i].per_value[j] = make_pair(ceil(per_value[j]), per_value[j+ num_shocks]); } } - int i; + int i = 0; for (vector::iterator it = spfplan.begin(); it != spfplan.end(); it++) { mexPrintf("----------------------------------------------------------------------------------------------------\n"); diff --git a/mex/sources/estimation/KalmanFilter.hh b/mex/sources/estimation/KalmanFilter.hh index b9203d610..25a4699fa 100644 --- a/mex/sources/estimation/KalmanFilter.hh +++ b/mex/sources/estimation/KalmanFilter.hh @@ -60,8 +60,6 @@ public: const Mat1 &Q, const Matrix &H, const Vec2 &deepParams, VectorView &vll, MatrixView &detrendedDataView, size_t start, size_t period) { - double lik = INFINITY; - if (period == 0) // initialise all KF matrices initKalmanFilter.initialize(steadyState, deepParams, R, Q, RQRt, T, Pstar, Pinf, dataView, detrendedDataView); diff --git a/mex/sources/estimation/Prior.cc b/mex/sources/estimation/Prior.cc index 1272a39c0..fdd5207fd 100644 --- a/mex/sources/estimation/Prior.cc +++ b/mex/sources/estimation/Prior.cc @@ -1,5 +1,5 @@ /* - * Copyright (C) 2009-2010 Dynare Team + * Copyright (C) 2009-2013 Dynare Team * * This file is part of Dynare. * @@ -54,4 +54,6 @@ Prior::constructPrior(pShape shape, double mean, double standard, double lower_b case Inv_gamma_2: return new InvGamma2_Prior(mean, standard, lower_bound, upper_bound, fhp, shp); } + std::cerr << "Unreacheable point" << std::endl; + exit(EXIT_FAILURE); } diff --git a/mex/sources/estimation/logMHMCMCposterior.cc b/mex/sources/estimation/logMHMCMCposterior.cc index 1db19cb63..a2a4a8b1d 100644 --- a/mex/sources/estimation/logMHMCMCposterior.cc +++ b/mex/sources/estimation/logMHMCMCposterior.cc @@ -501,7 +501,7 @@ sampleMHMC(LogPosteriorDensity &lpd, RandomWalkMetropolisHastings &rwmh, matClose(drawmat); #else - printf(" MH: Computing Metropolis-Hastings (chain %d/%d): %3.f \b%% done, acceptance rate: %3.f \b%%\r", b, nBlocks, 100 * j/nruns(b-1), 100 * sux / j); + printf(" MH: Computing Metropolis-Hastings (chain %ld/%ld): %3.f \b%% done, acceptance rate: %3.f \b%%\r", b, nBlocks, 100 * j/nruns(b-1), 100 * sux / j); // % Now I save the simulations // save draw 2 mat file ([MhDirectoryName '/' ModelName '_mh' int2str(NewFile(b)) '_blck' int2str(b) '.mat'],'x2','logpo2'); ssFName.clear(); @@ -716,7 +716,6 @@ logMCMCposterior(VectorConstView &estParams, const MatrixConstView &data, bool noconstant = (bool) *mxGetPr(mxGetField(options_, 0, "noconstant")); // Allocate LogPosteriorDensity object - int info; LogPosteriorDensity lpd(basename, epd, n_endo, n_exo, zeta_fwrd, zeta_back, zeta_mixed, zeta_static, qz_criterium, varobs, riccati_tol, lyapunov_tol, noconstant); diff --git a/mex/sources/estimation/logposterior.cc b/mex/sources/estimation/logposterior.cc index 72279f243..641244ce4 100644 --- a/mex/sources/estimation/logposterior.cc +++ b/mex/sources/estimation/logposterior.cc @@ -124,8 +124,6 @@ logposterior(VEC1 &estParams, const MatrixConstView &data, size_t n_endo = (size_t) *mxGetPr(mxGetField(M_, 0, "endo_nbr")); size_t n_exo = (size_t) *mxGetPr(mxGetField(M_, 0, "exo_nbr")); - size_t n_param = (size_t) *mxGetPr(mxGetField(M_, 0, "param_nbr")); - size_t n_estParams = estParams.getSize(); std::vector zeta_fwrd, zeta_back, zeta_mixed, zeta_static; const mxArray *lli_mx = mxGetField(M_, 0, "lead_lag_incidence"); diff --git a/mex/sources/k_order_perturbation/k_ord_dynare.cc b/mex/sources/k_order_perturbation/k_ord_dynare.cc index 7258611e7..91c96e0bc 100644 --- a/mex/sources/k_order_perturbation/k_ord_dynare.cc +++ b/mex/sources/k_order_perturbation/k_ord_dynare.cc @@ -1,5 +1,5 @@ /* - * Copyright (C) 2008-2011 Dynare Team + * Copyright (C) 2008-2013 Dynare Team * * This file is part of Dynare. * @@ -46,8 +46,8 @@ KordpDynare::KordpDynare(const vector &endo, int num_endo, nYs(npred + nboth), nYss(nboth + nforw), nY(num_endo), nJcols(jcols), NNZD(nnzd), nSteps(nsteps), nOrder(norder), journal(jr), ySteady(ysteady), params(inParams), vCov(vcov), md(1), dnl(*this, endo), denl(*this, exo), dsnl(*this, dnl, denl), ss_tol(sstol), varOrder(var_order), - ll_Incidence(llincidence), qz_criterium(criterium), dynamicModelFile(dynamicModelFile_arg), g1p(NULL), - g2p(NULL), g3p(NULL) + ll_Incidence(llincidence), qz_criterium(criterium), g1p(NULL), + g2p(NULL), g3p(NULL), dynamicModelFile(dynamicModelFile_arg) { ReorderDynareJacobianIndices(); @@ -68,8 +68,8 @@ KordpDynare::KordpDynare(const vector &endo, int num_endo, nYs(npred + nboth), nYss(nboth + nforw), nY(num_endo), nJcols(jcols), NNZD(nnzd), nSteps(nsteps), nOrder(norder), journal(jr), ySteady(ysteady), params(inParams), vCov(vcov), md(1), dnl(*this, endo), denl(*this, exo), dsnl(*this, dnl, denl), ss_tol(sstol), varOrder(var_order), - ll_Incidence(llincidence), qz_criterium(criterium), dynamicModelFile(dynamicModelFile_arg), - g1p(g1_arg), g2p(g2_arg), g3p(g3_arg) + ll_Incidence(llincidence), qz_criterium(criterium), + g1p(g1_arg), g2p(g2_arg), g3p(g3_arg), dynamicModelFile(dynamicModelFile_arg) { ReorderDynareJacobianIndices(); diff --git a/mex/sources/kalman_steady_state/kalman_steady_state.cc b/mex/sources/kalman_steady_state/kalman_steady_state.cc index 77c279bf6..74588aad4 100644 --- a/mex/sources/kalman_steady_state/kalman_steady_state.cc +++ b/mex/sources/kalman_steady_state/kalman_steady_state.cc @@ -93,7 +93,7 @@ mexFunction(int nlhs, mxArray *plhs[], int nrhs, const mxArray *prhs[]) // Check the type of the input arguments and get the size of the matrices. mwSize n = mxGetM(prhs[0]); - if (n != mxGetN(prhs[0])) + if ((size_t) n != mxGetN(prhs[0])) { DYN_MEX_FUNC_ERR_MSG_TXT("kalman_steady_state: The first input argument (T) must be a square matrix!"); } @@ -102,7 +102,7 @@ mexFunction(int nlhs, mxArray *plhs[], int nrhs, const mxArray *prhs[]) DYN_MEX_FUNC_ERR_MSG_TXT("kalman_steady_state: The first input argument (T) must be a real matrix!"); } mwSize q = mxGetM(prhs[1]); - if (q != mxGetN(prhs[1])) + if ((size_t) q != mxGetN(prhs[1])) { DYN_MEX_FUNC_ERR_MSG_TXT("kalman_steady_state: The second input argument (QQ) must be a square matrix!"); } @@ -115,7 +115,7 @@ mexFunction(int nlhs, mxArray *plhs[], int nrhs, const mxArray *prhs[]) DYN_MEX_FUNC_ERR_MSG_TXT("kalman_steady_state: The size of the second input argument (QQ) must match the size of the first argument (T)!"); } mwSize p = mxGetN(prhs[2]); - if (mxGetM(prhs[2]) != n) + if (mxGetM(prhs[2]) != (size_t) n) { DYN_MEX_FUNC_ERR_MSG_TXT("kalman_steady_state: The number of rows of the third argument (Z) must match the number of rows of the first argument (T)!"); } @@ -129,7 +129,7 @@ mexFunction(int nlhs, mxArray *plhs[], int nrhs, const mxArray *prhs[]) { DYN_MEX_FUNC_ERR_MSG_TXT("kalman_steady_state: The fourth input argument (H) must be a square matrix!"); } - if (mxGetM(prhs[3]) != p) + if (mxGetM(prhs[3]) != (size_t) p) { DYN_MEX_FUNC_ERR_MSG_TXT("kalman_steady_state: The number of rows of the fourth input argument (H) must match the number of rows of the third input argument!"); } diff --git a/mex/sources/local_state_space_iterations/local_state_space_iteration_2.cc b/mex/sources/local_state_space_iterations/local_state_space_iteration_2.cc index 3e2998183..131ad2d8e 100644 --- a/mex/sources/local_state_space_iterations/local_state_space_iteration_2.cc +++ b/mex/sources/local_state_space_iterations/local_state_space_iteration_2.cc @@ -267,10 +267,10 @@ void mexFunction(int nlhs, mxArray *plhs[], int nrhs, const mxArray *prhs[]) mexErrMsgTxt("Too many output arguments."); } // Get dimensions. - mwSize n = mxGetM(prhs[0]);// Number of states. - mwSize s = mxGetN(prhs[0]);// Number of particles. - mwSize q = mxGetM(prhs[1]);// Number of innovations. - mwSize m = mxGetM(prhs[2]);// Number of elements in the union of states and observed variables. + size_t n = mxGetM(prhs[0]);// Number of states. + size_t s = mxGetN(prhs[0]);// Number of particles. + size_t q = mxGetM(prhs[1]);// Number of innovations. + size_t m = mxGetM(prhs[2]);// Number of elements in the union of states and observed variables. //mexPrintf("\n s (the number of column of yhat) is equal to %d.", s); //mexPrintf("\n The number of column of epsilon is %d.", mxGetN(prhs[1])); // Check the dimensions. From 61485ab809d9a33484abf6136f05abd84da2be1b Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?S=C3=A9bastien=20Villemot?= Date: Wed, 12 Jun 2013 16:42:09 +0200 Subject: [PATCH 11/11] Fix copyright notices --- license.txt | 7 ++++++- m4/ax_gsl.m4 | 2 +- matlab/@dynDate/colon.m | 2 +- matlab/@dynDate/dynDate.m | 2 +- matlab/@dynDate/eq.m | 4 ++-- matlab/@dynDate/format.m | 2 +- matlab/@dynDate/ge.m | 4 ++-- matlab/@dynDate/gt.m | 4 ++-- matlab/@dynDate/isempty.m | 4 ++-- matlab/@dynDate/le.m | 4 ++-- matlab/@dynDate/lt.m | 2 +- matlab/@dynDate/max.m | 2 +- matlab/@dynDate/min.m | 2 +- matlab/@dynDate/minus.m | 4 ++-- matlab/@dynDate/ne.m | 2 +- matlab/@dynDate/plus.m | 4 ++-- matlab/@dynDate/subsref.m | 4 ++-- matlab/@dynDate/uminus.m | 2 +- matlab/@dynDate/uplus.m | 4 ++-- matlab/@dynDates/append.m | 2 +- matlab/@dynDates/sort.m | 2 +- matlab/@dynDates/unique.m | 2 +- matlab/@dynSeries/dynSeries.m | 2 +- matlab/@dynSeries/exp.m | 2 +- matlab/@dynSeries/extract.m | 2 +- matlab/@dynSeries/horzcat.m | 2 +- matlab/@dynSeries/isempty.m | 4 ++-- matlab/@dynSeries/log.m | 2 +- matlab/@dynSeries/minus.m | 2 +- matlab/@dynSeries/mrdivide.m | 2 +- matlab/@dynSeries/mtimes.m | 2 +- matlab/@dynSeries/numel.m | 4 ++-- matlab/@dynSeries/plus.m | 2 +- matlab/@dynSeries/private/horzcat2.m | 4 ++-- matlab/@dynSeries/qdiff.m | 4 ++-- matlab/@dynSeries/qgrowth.m | 4 ++-- matlab/@dynSeries/save.m | 21 +++++++++++++++++-- matlab/@dynSeries/subsasgn.m | 2 +- matlab/@dynSeries/subsref.m | 2 +- matlab/@dynSeries/uminus.m | 2 +- matlab/@dynSeries/ydiff.m | 2 +- matlab/@dynSeries/ygrowth.m | 4 ++-- matlab/AHessian.m | 2 +- matlab/CheckPath.m | 2 +- matlab/CutSample.m | 2 +- matlab/PosteriorIRF.m | 2 +- matlab/PosteriorIRF_core1.m | 2 +- matlab/adaptive_metropolis_hastings.m | 2 +- matlab/bvar_forecast.m | 2 +- matlab/cartesian_product_of_sets.m | 2 +- matlab/check_model.m | 2 +- matlab/check_posterior_analysis_data.m | 2 +- ...ional_variance_decomposition_mc_analysis.m | 2 +- matlab/correlation_mc_analysis.m | 2 +- matlab/cosn.m | 2 +- matlab/covariance_mc_analysis.m | 2 +- matlab/cubature_with_gaussian_weight.m | 2 +- matlab/disp_identification.m | 2 +- matlab/disp_th_moments.m | 2 +- ...splay_conditional_variance_decomposition.m | 2 +- matlab/dr_block.m | 2 +- matlab/dsge_likelihood.m | 2 +- matlab/dyn_forecast.m | 2 +- matlab/dynare.m | 2 +- matlab/dynare_estimation.m | 2 +- matlab/dynare_estimation_init.m | 2 +- matlab/dynare_identification.m | 2 +- matlab/dynare_sensitivity.m | 2 +- matlab/ep/extended_path.m | 2 +- ...solve_stochastic_perfect_foresight_model.m | 2 +- ...lve_stochastic_perfect_foresight_model_1.m | 2 +- matlab/fastgensylv.m | 16 -------------- matlab/forecast_graphs.m | 2 +- matlab/gauss_hermite_weights_and_nodes.m | 2 +- matlab/getJJ.m | 2 +- matlab/global_initialization.m | 2 +- matlab/graph_decomp.m | 2 +- matlab/gsa/filt_mc_.m | 2 +- matlab/gsa/map_ident_.m | 2 +- matlab/gsa/redform_map.m | 2 +- matlab/gsa/redform_screen.m | 2 +- matlab/gsa/stab_map_.m | 2 +- matlab/gsa/stab_map_1.m | 2 +- matlab/gsa/stab_map_2.m | 2 +- matlab/ident_bruteforce.m | 2 +- matlab/identification_analysis.m | 2 +- matlab/independent_metropolis_hastings.m | 2 +- matlab/independent_metropolis_hastings_core.m | 2 +- matlab/k_order_perturbation.m | 17 +++++++++++++++ matlab/kalman/likelihood/kalman_filter.m | 2 +- matlab/kalman/likelihood/kalman_filter_d.m | 2 +- matlab/kronecker/A_times_B_kronecker_C.m | 2 +- .../sparse_hessian_times_B_kronecker_C.m | 2 +- matlab/load_csv_file_data.m | 2 +- matlab/load_m_file_data.m | 5 ++--- matlab/load_mat_file_data.m | 5 ++--- matlab/maximize_prior_density.m | 2 +- matlab/metropolis_hastings_initialization.m | 2 +- matlab/mh_autocorrelation_function.m | 2 +- matlab/minus_logged_prior_density.m | 2 +- matlab/mode_check.m | 2 +- matlab/ms-sbvar/sbvar.m | 2 +- matlab/newrat.m | 2 +- matlab/non_linear_dsge_likelihood.m | 2 +- .../AnalyseComputationalEnvironment.m | 2 +- matlab/parallel/GiveCPUnumber.m | 2 +- .../InitializeComputationalEnvironment.m | 2 +- matlab/parallel/closeSlave.m | 2 +- matlab/parallel/dynareParallelDelete.m | 2 +- .../parallel/dynareParallelDeleteNewFiles.m | 2 +- matlab/parallel/dynareParallelDir.m | 2 +- matlab/parallel/dynareParallelGetFiles.m | 2 +- matlab/parallel/dynareParallelGetNewFiles.m | 2 +- matlab/parallel/dynareParallelListAllFiles.m | 2 +- matlab/parallel/dynareParallelMkDir.m | 2 +- matlab/parallel/dynareParallelRmDir.m | 2 +- matlab/parallel/dynareParallelSendFiles.m | 2 +- matlab/parallel/masterParallel.m | 2 +- matlab/particle/conditional_particle_filter.m | 2 +- matlab/particle/fit_gaussian_mixture.m | 18 ++++++++++++++++ matlab/particle/gaussian_densities.m | 2 +- matlab/particle/gaussian_filter_bank.m | 2 +- matlab/particle/importance_sampling.m | 18 ++++++++++++++++ .../local_state_space_iteration_2.m | 2 +- matlab/particle/measurement_equations.m | 18 ++++++++++++++++ matlab/particle/mykmeans.m | 20 +++++++++++++++++- matlab/particle/neff.m | 19 ++++++++++++++++- matlab/particle/probability.m | 18 ++++++++++++++++ matlab/particle/probability2.m | 2 +- .../particle/spherical_radial_sigma_points.m | 2 +- matlab/plot_icforecast.m | 2 +- matlab/plot_identification.m | 2 +- matlab/pm3.m | 2 +- matlab/prior_bounds.m | 2 +- matlab/priordens.m | 2 +- matlab/qr2.m | 2 +- matlab/random_walk_metropolis_hastings.m | 2 +- matlab/random_walk_metropolis_hastings_core.m | 2 +- matlab/rplot.m | 2 +- matlab/set_all_parameters.m | 2 +- ...tochastic_perfect_foresight_model_solver.m | 19 ++++++++++++++++- matlab/sim1.m | 2 +- matlab/sim1_purely_backward.m | 2 +- matlab/simul.m | 2 +- matlab/simult_.m | 2 +- matlab/step_length_correction.m | 20 +++++++++++++++++- matlab/stoch_simul.m | 2 +- matlab/stochastic_solvers.m | 2 +- matlab/thet2tau.m | 2 +- matlab/utilities/dataset/compute_acov.m | 2 +- matlab/utilities/dataset/compute_corr.m | 2 +- matlab/utilities/dataset/compute_cova.m | 2 +- matlab/utilities/dataset/compute_stdv.m | 2 +- .../utilities/dataset/describe_missing_data.m | 2 +- .../dataset/descriptive_statistics.m | 2 +- matlab/utilities/dataset/initialize_dataset.m | 2 +- matlab/utilities/doc/dynInfo.m | 2 +- matlab/utilities/doc/get_internal_doc_block.m | 2 +- matlab/utilities/general/demean.m | 2 +- matlab/utilities/general/iscellofchar.m | 2 +- matlab/utilities/general/ndim.m | 2 +- matlab/utilities/tests/dyn_assert.m | 2 +- matlab/utilities/tests/mtest.m | 2 +- matlab/variance_decomposition_mc_analysis.m | 2 +- .../block_kalman_filter.cc | 2 +- .../block_kalman_filter/block_kalman_filter.h | 2 +- mex/sources/bytecode/ErrorHandling.hh | 2 +- mex/sources/bytecode/Evaluate.cc | 19 +++++++++++++++++ mex/sources/bytecode/Evaluate.hh | 2 +- mex/sources/bytecode/Interpreter.cc | 2 +- mex/sources/bytecode/Interpreter.hh | 2 +- mex/sources/bytecode/SparseMatrix.hh | 2 +- mex/sources/bytecode/bytecode.cc | 2 +- mex/sources/dynblas.h | 2 +- mex/sources/estimation/tests/DsgeLikelihood.m | 2 +- .../k_order_perturbation/k_ord_dynare.hh | 2 +- .../kalman_steady_state.cc | 2 +- .../local_state_space_iteration_2.cc | 2 +- mex/sources/ms-sbvar/modify_for_mex.cc | 2 +- mex/sources/ordschur/ordschur.cc | 2 +- mex/sources/qzcomplex/qzcomplex.cc | 2 +- preprocessor/ConfigFile.cc | 2 +- preprocessor/DynamicModel.cc | 2 +- preprocessor/DynamicModel.hh | 2 +- preprocessor/ModelTree.cc | 2 +- preprocessor/ModelTree.hh | 2 +- preprocessor/NumericalConstants.cc | 2 +- preprocessor/NumericalConstants.hh | 2 +- preprocessor/NumericalInitialization.cc | 2 +- preprocessor/StaticModel.hh | 2 +- tests/internals/tests.m | 2 +- .../fs2000_corr_ME_steadystate.m | 2 +- 192 files changed, 403 insertions(+), 221 deletions(-) diff --git a/license.txt b/license.txt index ce6356598..2dcfdcf07 100644 --- a/license.txt +++ b/license.txt @@ -45,7 +45,7 @@ Files: matlab/bfgsi1.m matlab/csolve.m matlab/csminit1.m matlab/numgrad2.m matlab/bvar_toolbox.m matlab/partial_information/PI_gensys.m matlab/qzswitch.m matlab/qzdiv.m Copyright: 1993-2009 Christopher Sims - 2006-2011 Dynare Team + 2006-2012 Dynare Team License: GPL-3+ Files: matlab/cmaes.m @@ -53,6 +53,11 @@ Copyright: 2001-2012 Nikolaus Hansen 2012 Dynare Team License: GPL-3+ +Files: matlab/endogenous_prior.m +Copyright: 2011 Lawrence J. Christiano, Mathias Trabandt and Karl Walentin + 2013 Dynare Team +License: GPL-3+ + Files: matlab/missing/stats/normpdf.m matlab/missing/stats/gamcdf.m matlab/missing/stats/common_size.m matlab/missing/stats/chi2inv.m matlab/missing/stats/gaminv.m matlab/missing/stats/gampdf.m diff --git a/m4/ax_gsl.m4 b/m4/ax_gsl.m4 index af90668fb..11920cdb0 100644 --- a/m4/ax_gsl.m4 +++ b/m4/ax_gsl.m4 @@ -2,7 +2,7 @@ dnl Detect GSL. dnl We don't use the official M4 macro since it relies on the script gsl-config, dnl which does not work when cross-compiling. dnl -dnl Copyright (C) 2010 Dynare Team +dnl Copyright (C) 2010-2012 Dynare Team dnl dnl This file is part of Dynare. dnl diff --git a/matlab/@dynDate/colon.m b/matlab/@dynDate/colon.m index ee260b66a..5c6e22f66 100644 --- a/matlab/@dynDate/colon.m +++ b/matlab/@dynDate/colon.m @@ -30,7 +30,7 @@ function sp = colon(a,b) %! @end deftypefn %@eod: -% Copyright (C) 2011, 2012 Dynare Team +% Copyright (C) 2011-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/@dynDate/dynDate.m b/matlab/@dynDate/dynDate.m index f8c710887..e6af26bb5 100644 --- a/matlab/@dynDate/dynDate.m +++ b/matlab/@dynDate/dynDate.m @@ -43,7 +43,7 @@ function date = dynDate(a,b) %! @end deftypefn %@eod: -% Copyright (C) 2011 Dynare Team +% Copyright (C) 2011-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/@dynDate/eq.m b/matlab/@dynDate/eq.m index 0466ce542..64367e1d9 100644 --- a/matlab/@dynDate/eq.m +++ b/matlab/@dynDate/eq.m @@ -29,7 +29,7 @@ function c = eq(a,b) %! @end deftypefn %@eod: -% Copyright (C) 2011, 2012 Dynare Team +% Copyright (C) 2011-2013 Dynare Team % % This file is part of Dynare. % @@ -121,4 +121,4 @@ c = isequal(a.time,b.time); %$ t(2) = dyn_assert(i2,1); %$ t(3) = dyn_assert(i3,0); %$ T = all(t); -%@eof:2 \ No newline at end of file +%@eof:2 diff --git a/matlab/@dynDate/format.m b/matlab/@dynDate/format.m index 93357196d..df403148a 100644 --- a/matlab/@dynDate/format.m +++ b/matlab/@dynDate/format.m @@ -27,7 +27,7 @@ function p = format(date) %! @end deftypefn %@eod: -% Copyright (C) 2011 Dynare Team +% Copyright (C) 2011-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/@dynDate/ge.m b/matlab/@dynDate/ge.m index 098988ae7..05fa1850d 100644 --- a/matlab/@dynDate/ge.m +++ b/matlab/@dynDate/ge.m @@ -30,7 +30,7 @@ function c = ge(a,b) %! @end deftypefn %@eod: -% Copyright (C) 2011, 2013 Dynare Team +% Copyright (C) 2011-2013 Dynare Team % % This file is part of Dynare. % @@ -80,4 +80,4 @@ end %$ t(3) = dyn_assert(i3,0); %$ t(4) = dyn_assert(i4,1); %$ T = all(t); -%@eof:1 \ No newline at end of file +%@eof:1 diff --git a/matlab/@dynDate/gt.m b/matlab/@dynDate/gt.m index 4cefe3f4e..c881b1942 100644 --- a/matlab/@dynDate/gt.m +++ b/matlab/@dynDate/gt.m @@ -29,7 +29,7 @@ function c = gt(a,b) %! @end deftypefn %@eod: -% Copyright (C) 2011, 2012 Dynare Team +% Copyright (C) 2011-2013 Dynare Team % % This file is part of Dynare. % @@ -95,4 +95,4 @@ end %$ t(3) = dyn_assert(i3,0); %$ t(4) = dyn_assert(i4,0); %$ T = all(t); -%@eof:1 \ No newline at end of file +%@eof:1 diff --git a/matlab/@dynDate/isempty.m b/matlab/@dynDate/isempty.m index e00b26212..ee90a40e3 100644 --- a/matlab/@dynDate/isempty.m +++ b/matlab/@dynDate/isempty.m @@ -27,7 +27,7 @@ function b = isempty(a) %! @end deftypefn %@eod: -% Copyright (C) 2012, 2013 Dynare Team +% Copyright (C) 2012-2013 Dynare Team % % This file is part of Dynare. % @@ -56,4 +56,4 @@ b = all(isnan(a.time)) && isnan(a.freq); %$ % Test if this object is empty %$ t(1) = isempty(d); %$ T = all(t); -%@eof:1 \ No newline at end of file +%@eof:1 diff --git a/matlab/@dynDate/le.m b/matlab/@dynDate/le.m index b3f3dd79f..14b198330 100644 --- a/matlab/@dynDate/le.m +++ b/matlab/@dynDate/le.m @@ -30,7 +30,7 @@ function c = le(a,b) %! @end deftypefn %@eod: -% Copyright (C) 2011, 2013 Dynare Team +% Copyright (C) 2011-2013 Dynare Team % % This file is part of Dynare. % @@ -80,4 +80,4 @@ end %$ t(3) = dyn_assert(i3,1); %$ t(4) = dyn_assert(i4,0); %$ T = all(t); -%@eof:1 \ No newline at end of file +%@eof:1 diff --git a/matlab/@dynDate/lt.m b/matlab/@dynDate/lt.m index a2f3941c7..0aef47153 100644 --- a/matlab/@dynDate/lt.m +++ b/matlab/@dynDate/lt.m @@ -29,7 +29,7 @@ function c = lt(a,b) %! @end deftypefn %@eod: -% Copyright (C) 2011, 2012 Dynare Team +% Copyright (C) 2011-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/@dynDate/max.m b/matlab/@dynDate/max.m index daa62831f..451c050f6 100644 --- a/matlab/@dynDate/max.m +++ b/matlab/@dynDate/max.m @@ -29,7 +29,7 @@ function c = max(a,b) %! @end deftypefn %@eod: -% Copyright (C) 2011 Dynare Team +% Copyright (C) 2011-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/@dynDate/min.m b/matlab/@dynDate/min.m index df8c0c9c3..78c7281af 100644 --- a/matlab/@dynDate/min.m +++ b/matlab/@dynDate/min.m @@ -29,7 +29,7 @@ function c = min(a,b) %! @end deftypefn %@eod: -% Copyright (C) 2011, 2012 Dynare Team +% Copyright (C) 2011-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/@dynDate/minus.m b/matlab/@dynDate/minus.m index 3559af74d..248cb679c 100644 --- a/matlab/@dynDate/minus.m +++ b/matlab/@dynDate/minus.m @@ -31,7 +31,7 @@ function c = minus(a,b) %! @end deftypefn %@eod: -% Copyright (C) 2011, 2013 Dynare Team +% Copyright (C) 2011-2013 Dynare Team % % This file is part of Dynare. % @@ -107,4 +107,4 @@ end %$ t(4) = dyn_assert(e4,41); %$ t(4) = dyn_assert(e5,19); %$ T = all(t); -%@eof:1 \ No newline at end of file +%@eof:1 diff --git a/matlab/@dynDate/ne.m b/matlab/@dynDate/ne.m index 9a647839a..d6ae7f1f1 100644 --- a/matlab/@dynDate/ne.m +++ b/matlab/@dynDate/ne.m @@ -29,7 +29,7 @@ function c = ne(a,b) %! @end deftypefn %@eod: -% Copyright (C) 2011, 2012 Dynare Team +% Copyright (C) 2011-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/@dynDate/plus.m b/matlab/@dynDate/plus.m index 968e4e610..e110596bd 100644 --- a/matlab/@dynDate/plus.m +++ b/matlab/@dynDate/plus.m @@ -31,7 +31,7 @@ function c = plus(a,b) %! @end deftypefn %@eod: -% Copyright (C) 2011, 2013 Dynare Team +% Copyright (C) 2011-2013 Dynare Team % % This file is part of Dynare. % @@ -104,4 +104,4 @@ end %$ t(3) = dyn_assert(e3.time,d3.time); %$ t(4) = dyn_assert(e4.time,d4.time); %$ T = all(t); -%@eof:1 \ No newline at end of file +%@eof:1 diff --git a/matlab/@dynDate/subsref.m b/matlab/@dynDate/subsref.m index 486983153..6186eb6f0 100644 --- a/matlab/@dynDate/subsref.m +++ b/matlab/@dynDate/subsref.m @@ -32,7 +32,7 @@ function B = subsref(A,S) %! @end deftypefn %@eod: -% Copyright (C) 2011, 2012, 2013 Dynare Team +% Copyright (C) 2011-2013 Dynare Team % % This file is part of Dynare. % @@ -235,4 +235,4 @@ end %$ t(1) = dyn_assert(qq.freq,4); %$ t(2) = dyn_assert(time,[1938,4]); %$ T = all(t); -%@eof:5 \ No newline at end of file +%@eof:5 diff --git a/matlab/@dynDate/uminus.m b/matlab/@dynDate/uminus.m index 3e29d0100..814afe12e 100644 --- a/matlab/@dynDate/uminus.m +++ b/matlab/@dynDate/uminus.m @@ -29,7 +29,7 @@ function b = uminus(a) %! @end deftypefn %@eod: -% Copyright (C) 2011, 2013 Dynare Team +% Copyright (C) 2011-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/@dynDate/uplus.m b/matlab/@dynDate/uplus.m index 60555f36c..054057215 100644 --- a/matlab/@dynDate/uplus.m +++ b/matlab/@dynDate/uplus.m @@ -29,7 +29,7 @@ function b = uplus(a) %! @end deftypefn %@eod: -% Copyright (C) 2011, 2013 Dynare Team +% Copyright (C) 2011-2013 Dynare Team % % This file is part of Dynare. % @@ -115,4 +115,4 @@ end %$ t(6) = dyn_assert(e6.time,[1951 1]); %$ t(7) = dyn_assert(e7.time,[2001 1]); %$ T = all(t); -%@eof:1 \ No newline at end of file +%@eof:1 diff --git a/matlab/@dynDates/append.m b/matlab/@dynDates/append.m index 8a64cc5f4..651b95e0a 100644 --- a/matlab/@dynDates/append.m +++ b/matlab/@dynDates/append.m @@ -30,7 +30,7 @@ function dd = append(dd,a) %! @end deftypefn %@eod: -% Copyright (C) 2012 Dynare Team +% Copyright (C) 2012-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/@dynDates/sort.m b/matlab/@dynDates/sort.m index a0ff995ea..52467bfc4 100644 --- a/matlab/@dynDates/sort.m +++ b/matlab/@dynDates/sort.m @@ -28,7 +28,7 @@ function dd = sort(dd) %! @end deftypefn %@eod: -% Copyright (C) 2011 Dynare Team +% Copyright (C) 2011-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/@dynDates/unique.m b/matlab/@dynDates/unique.m index b1ab9f4c4..b37292fb8 100644 --- a/matlab/@dynDates/unique.m +++ b/matlab/@dynDates/unique.m @@ -28,7 +28,7 @@ function dd = unique(dd) %! @end deftypefn %@eod: -% Copyright (C) 2012 Dynare Team +% Copyright (C) 2012-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/@dynSeries/dynSeries.m b/matlab/@dynSeries/dynSeries.m index 5566d3cee..94114f868 100644 --- a/matlab/@dynSeries/dynSeries.m +++ b/matlab/@dynSeries/dynSeries.m @@ -59,7 +59,7 @@ function ts = dynSeries(varargin) %! @end deftypefn %@eod: -% Copyright (C) 2011, 2012, 2013 Dynare Team +% Copyright (C) 2011-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/@dynSeries/exp.m b/matlab/@dynSeries/exp.m index 58c4f71a5..3690ae4bb 100644 --- a/matlab/@dynSeries/exp.m +++ b/matlab/@dynSeries/exp.m @@ -27,7 +27,7 @@ function ts = exp(ts) %! @end deftypefn %@eod: -% Copyright (C) 2011 Dynare Team +% Copyright (C) 2011-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/@dynSeries/extract.m b/matlab/@dynSeries/extract.m index a22c211f6..547501ea6 100644 --- a/matlab/@dynSeries/extract.m +++ b/matlab/@dynSeries/extract.m @@ -1,7 +1,7 @@ function A = extract(B,varargin) % Extract some variables from a database. -% Copyright (C) 2012, 2013 Dynare Team +% Copyright (C) 2012-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/@dynSeries/horzcat.m b/matlab/@dynSeries/horzcat.m index 132bf220c..97ea8ebc6 100644 --- a/matlab/@dynSeries/horzcat.m +++ b/matlab/@dynSeries/horzcat.m @@ -39,7 +39,7 @@ function a = horzcat(varargin) %! @end deftypefn %@eod: -% Copyright (C) 2011 Dynare Team +% Copyright (C) 2011-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/@dynSeries/isempty.m b/matlab/@dynSeries/isempty.m index b6f2fbb8c..049ceb7b9 100644 --- a/matlab/@dynSeries/isempty.m +++ b/matlab/@dynSeries/isempty.m @@ -20,7 +20,7 @@ function b = isempty(A) %! @end deftypefn %@eod: -% Copyright (C) 2011, 2012 Dynare Team +% Copyright (C) 2011-2012 Dynare Team % % This file is part of Dynare. % @@ -39,4 +39,4 @@ function b = isempty(A) % AUTHOR(S) stephane DOT adjemian AT univ DASH lemans DOT fr -b = isempty(A.data) && isequal(A.nobs,0) && isequal(A.vobs,0); \ No newline at end of file +b = isempty(A.data) && isequal(A.nobs,0) && isequal(A.vobs,0); diff --git a/matlab/@dynSeries/log.m b/matlab/@dynSeries/log.m index 563dfbcbb..dd4127e9b 100644 --- a/matlab/@dynSeries/log.m +++ b/matlab/@dynSeries/log.m @@ -26,7 +26,7 @@ function ts = log(ts) %! @end deftypefn %@eod: -% Copyright (C) 2011 Dynare Team +% Copyright (C) 2011-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/@dynSeries/minus.m b/matlab/@dynSeries/minus.m index fed87a01c..0731729f0 100644 --- a/matlab/@dynSeries/minus.m +++ b/matlab/@dynSeries/minus.m @@ -22,7 +22,7 @@ function A = minus(B,C) %! @end deftypefn %@eod: -% Copyright (C) 2012 Dynare Team +% Copyright (C) 2012-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/@dynSeries/mrdivide.m b/matlab/@dynSeries/mrdivide.m index bda90a998..cabc91636 100644 --- a/matlab/@dynSeries/mrdivide.m +++ b/matlab/@dynSeries/mrdivide.m @@ -22,7 +22,7 @@ function A = mrdivide(B,C) %! @end deftypefn %@eod: -% Copyright (C) 2012 Dynare Team +% Copyright (C) 2012-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/@dynSeries/mtimes.m b/matlab/@dynSeries/mtimes.m index b92c3d726..b81cd4145 100644 --- a/matlab/@dynSeries/mtimes.m +++ b/matlab/@dynSeries/mtimes.m @@ -22,7 +22,7 @@ function A = mtimes(B,C) %! @end deftypefn %@eod: -% Copyright (C) 2012 Dynare Team +% Copyright (C) 2012-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/@dynSeries/numel.m b/matlab/@dynSeries/numel.m index e53acd80a..85cd84962 100644 --- a/matlab/@dynSeries/numel.m +++ b/matlab/@dynSeries/numel.m @@ -1,6 +1,6 @@ function n = numel(obj, varargin) -% Copyright (C) 2012, 2013 Dynare Team +% Copyright (C) 2012-2013 Dynare Team % % This file is part of Dynare. % @@ -17,4 +17,4 @@ function n = numel(obj, varargin) % You should have received a copy of the GNU General Public License % along with Dynare. If not, see . -n = 1; \ No newline at end of file +n = 1; diff --git a/matlab/@dynSeries/plus.m b/matlab/@dynSeries/plus.m index 1cebc04ff..9d6482c8f 100644 --- a/matlab/@dynSeries/plus.m +++ b/matlab/@dynSeries/plus.m @@ -22,7 +22,7 @@ function A = plus(B,C) %! @end deftypefn %@eod: -% Copyright (C) 2011, 2012 Dynare Team +% Copyright (C) 2011-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/@dynSeries/private/horzcat2.m b/matlab/@dynSeries/private/horzcat2.m index 28668db57..b25728f48 100644 --- a/matlab/@dynSeries/private/horzcat2.m +++ b/matlab/@dynSeries/private/horzcat2.m @@ -39,7 +39,7 @@ function a = horzcat2(b,c) %! @end deftypefn %@eod: -% Copyright (C) 2011, 2013 Dynare Team +% Copyright (C) 2011-2013 Dynare Team % % This file is part of Dynare. % @@ -109,4 +109,4 @@ else a.data = [b.data, c.data]; a.time = unique(b.time.append(c.time)); end -a.nobs = size(a.data,1); \ No newline at end of file +a.nobs = size(a.data,1); diff --git a/matlab/@dynSeries/qdiff.m b/matlab/@dynSeries/qdiff.m index e6b622de7..e11dd3b5f 100644 --- a/matlab/@dynSeries/qdiff.m +++ b/matlab/@dynSeries/qdiff.m @@ -22,7 +22,7 @@ function us = qdiff(ts) %! @end deftypefn %@eod: -% Copyright (C) 2012, 2013 Dynare Team +% Copyright (C) 2012-2013 Dynare Team % % This file is part of Dynare. % @@ -104,4 +104,4 @@ end %$ end %$ %$ T = all(t); -%@eof:2 \ No newline at end of file +%@eof:2 diff --git a/matlab/@dynSeries/qgrowth.m b/matlab/@dynSeries/qgrowth.m index a1118f35b..8823e70ca 100644 --- a/matlab/@dynSeries/qgrowth.m +++ b/matlab/@dynSeries/qgrowth.m @@ -22,7 +22,7 @@ function us = qgrowth(ts) %! @end deftypefn %@eod: -% Copyright (C) 2012, 2013 Dynare Team +% Copyright (C) 2012-2013 Dynare Team % % This file is part of Dynare. % @@ -104,4 +104,4 @@ end %$ end %$ %$ T = all(t); -%@eof:2 \ No newline at end of file +%@eof:2 diff --git a/matlab/@dynSeries/save.m b/matlab/@dynSeries/save.m index 205066180..f2ea10a69 100644 --- a/matlab/@dynSeries/save.m +++ b/matlab/@dynSeries/save.m @@ -1,6 +1,23 @@ function save(A,basename,format) % Saves a dynSeries object on disk. - + +% Copyright (C) 2013 Dynare Team +% +% This file is part of Dynare. +% +% Dynare is free software: you can redistribute it and/or modify +% it under the terms of the GNU General Public License as published by +% the Free Software Foundation, either version 3 of the License, or +% (at your option) any later version. +% +% Dynare is distributed in the hope that it will be useful, +% but WITHOUT ANY WARRANTY; without even the implied warranty of +% MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the +% GNU General Public License for more details. +% +% You should have received a copy of the GNU General Public License +% along with Dynare. If not, see . + if nargin<3 || isempty(format) format = 'csv'; end @@ -136,4 +153,4 @@ end %$ end %$ %$ T = all(t); -%@eof:4 \ No newline at end of file +%@eof:4 diff --git a/matlab/@dynSeries/subsasgn.m b/matlab/@dynSeries/subsasgn.m index 55e351d0b..4eb6a2d10 100644 --- a/matlab/@dynSeries/subsasgn.m +++ b/matlab/@dynSeries/subsasgn.m @@ -8,7 +8,7 @@ function A = subsasgn(A,S,B) %! @end deftypefn %@eod: -% Copyright (C) 2012, 2013 Dynare Team +% Copyright (C) 2012-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/@dynSeries/subsref.m b/matlab/@dynSeries/subsref.m index 249cdbee5..a2de5cd6c 100644 --- a/matlab/@dynSeries/subsref.m +++ b/matlab/@dynSeries/subsref.m @@ -44,7 +44,7 @@ function B = subsref(A, S) %! @end deftypefn %@eod: -% Copyright (C) 2011, 2012, 2013 Dynare Team +% Copyright (C) 2011-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/@dynSeries/uminus.m b/matlab/@dynSeries/uminus.m index edbd45b04..a8a6100f8 100644 --- a/matlab/@dynSeries/uminus.m +++ b/matlab/@dynSeries/uminus.m @@ -22,7 +22,7 @@ function A = uminus(B) %! @end deftypefn %@eod: -% Copyright (C) 2012, 2013 Dynare Team +% Copyright (C) 2012-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/@dynSeries/ydiff.m b/matlab/@dynSeries/ydiff.m index 5c8972ffd..fbaa0489c 100644 --- a/matlab/@dynSeries/ydiff.m +++ b/matlab/@dynSeries/ydiff.m @@ -23,7 +23,7 @@ function us = ydiff(ts) %! @end deftypefn %@eod: -% Copyright (C) 2012, 2013 Dynare Team +% Copyright (C) 2012-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/@dynSeries/ygrowth.m b/matlab/@dynSeries/ygrowth.m index 626feb162..32a7161ef 100644 --- a/matlab/@dynSeries/ygrowth.m +++ b/matlab/@dynSeries/ygrowth.m @@ -22,7 +22,7 @@ function us = ygrowth(ts) %! @end deftypefn %@eod: -% Copyright (C) 2012, 2013 Dynare Team +% Copyright (C) 2012-2013 Dynare Team % % This file is part of Dynare. % @@ -138,4 +138,4 @@ end %$ end %$ %$ T = all(t); -%@eof:3 \ No newline at end of file +%@eof:3 diff --git a/matlab/AHessian.m b/matlab/AHessian.m index 02cd7f0a3..2999ce715 100644 --- a/matlab/AHessian.m +++ b/matlab/AHessian.m @@ -8,7 +8,7 @@ function [AHess, DLIK, LIK] = AHessian(T,R,Q,H,P,Y,DT,DYss,DOm,DH,DP,start,mf,ka % NOTE: the derivative matrices (DT,DR ...) are 3-dim. arrays with last % dimension equal to the number of structural parameters -% Copyright (C) 2011 Dynare Team +% Copyright (C) 2011-2012 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/CheckPath.m b/matlab/CheckPath.m index fde154c9a..7e6c89f81 100644 --- a/matlab/CheckPath.m +++ b/matlab/CheckPath.m @@ -11,7 +11,7 @@ function DirectoryName = CheckPath(type,dname) % SPECIAL REQUIREMENTS % none -% Copyright (C) 2005-2011 Dynare Team +% Copyright (C) 2005-2012 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/CutSample.m b/matlab/CutSample.m index 5caf2237d..cc166a5f0 100644 --- a/matlab/CutSample.m +++ b/matlab/CutSample.m @@ -14,7 +14,7 @@ function CutSample(M_, options_, estim_params_) % SPECIAL REQUIREMENTS % none -% Copyright (C) 2005-2011 Dynare Team +% Copyright (C) 2005-2012 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/PosteriorIRF.m b/matlab/PosteriorIRF.m index b45293171..42e11640a 100644 --- a/matlab/PosteriorIRF.m +++ b/matlab/PosteriorIRF.m @@ -16,7 +16,7 @@ function PosteriorIRF(type) % functions associated with it(the _core1 and _core2). % See also the comments random_walk_metropolis_hastings.m funtion. -% Copyright (C) 2006-2012 Dynare Team +% Copyright (C) 2006-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/PosteriorIRF_core1.m b/matlab/PosteriorIRF_core1.m index a08efa367..20294afa2 100644 --- a/matlab/PosteriorIRF_core1.m +++ b/matlab/PosteriorIRF_core1.m @@ -22,7 +22,7 @@ function myoutput=PosteriorIRF_core1(myinputs,fpar,B,whoiam, ThisMatlab) % SPECIAL REQUIREMENTS. % None. % -% Copyright (C) 2006-2012 Dynare Team +% Copyright (C) 2006-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/adaptive_metropolis_hastings.m b/matlab/adaptive_metropolis_hastings.m index 2b0cb451a..08edbc1d4 100644 --- a/matlab/adaptive_metropolis_hastings.m +++ b/matlab/adaptive_metropolis_hastings.m @@ -34,7 +34,7 @@ function record=adaptive_metropolis_hastings(TargetFun,ProposalFun,xparam1,vv,mh % Then the comments write here can be used for all the other pairs of % parallel functions and also for management funtions. -% Copyright (C) 2006-2011 Dynare Team +% Copyright (C) 2006-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/bvar_forecast.m b/matlab/bvar_forecast.m index 3ce2883cd..3ee4aad95 100644 --- a/matlab/bvar_forecast.m +++ b/matlab/bvar_forecast.m @@ -11,7 +11,7 @@ function bvar_forecast(nlags) % SPECIAL REQUIREMENTS % none -% Copyright (C) 2007-2012 Dynare Team +% Copyright (C) 2007-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/cartesian_product_of_sets.m b/matlab/cartesian_product_of_sets.m index 8781a7e60..8901886ff 100644 --- a/matlab/cartesian_product_of_sets.m +++ b/matlab/cartesian_product_of_sets.m @@ -31,7 +31,7 @@ function cprod = cartesian_product_of_sets(varargin) %! @end deftypefn %@eod: -% Copyright (C) 2011 Dynare Team +% Copyright (C) 2011-2012 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/check_model.m b/matlab/check_model.m index 8ab34e393..3edf7b746 100644 --- a/matlab/check_model.m +++ b/matlab/check_model.m @@ -1,6 +1,6 @@ function check_model(DynareModel) -% Copyright (C) 2005-2011 Dynare Team +% Copyright (C) 2005-2012 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/check_posterior_analysis_data.m b/matlab/check_posterior_analysis_data.m index f3f7a6615..96c9e78ae 100644 --- a/matlab/check_posterior_analysis_data.m +++ b/matlab/check_posterior_analysis_data.m @@ -1,6 +1,6 @@ function [info,description] = check_posterior_analysis_data(type,M_) -% Copyright (C) 2008-2009 Dynare Team +% Copyright (C) 2008-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/conditional_variance_decomposition_mc_analysis.m b/matlab/conditional_variance_decomposition_mc_analysis.m index e896f10a7..004239800 100644 --- a/matlab/conditional_variance_decomposition_mc_analysis.m +++ b/matlab/conditional_variance_decomposition_mc_analysis.m @@ -3,7 +3,7 @@ function oo_ = ... % This function analyses the (posterior or prior) distribution of the % endogenous conditional variance decomposition. -% Copyright (C) 2009-2010 Dynare Team +% Copyright (C) 2009-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/correlation_mc_analysis.m b/matlab/correlation_mc_analysis.m index 3625955da..4654b50bd 100644 --- a/matlab/correlation_mc_analysis.m +++ b/matlab/correlation_mc_analysis.m @@ -2,7 +2,7 @@ function oo_ = correlation_mc_analysis(SampleSize,type,dname,fname,vartan,nvar,v % This function analyses the (posterior or prior) distribution of the % endogenous variables correlation function. -% Copyright (C) 2008-2009 Dynare Team +% Copyright (C) 2008-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/cosn.m b/matlab/cosn.m index 216efd193..8fcf7fb79 100644 --- a/matlab/cosn.m +++ b/matlab/cosn.m @@ -7,7 +7,7 @@ function [co, b, yhat] = cosn(H); % Not the same as multiple correlation coefficient since the means are not % zero % -% Copyright (C) 2008-2011 Dynare Team +% Copyright (C) 2008-2012 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/covariance_mc_analysis.m b/matlab/covariance_mc_analysis.m index b35060e40..a24ec665e 100644 --- a/matlab/covariance_mc_analysis.m +++ b/matlab/covariance_mc_analysis.m @@ -2,7 +2,7 @@ function oo_ = covariance_mc_analysis(NumberOfSimulations,type,dname,fname,varta % This function analyses the (posterior or prior) distribution of the % endogenous variables covariance matrix. -% Copyright (C) 2008-2009 Dynare Team +% Copyright (C) 2008-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/cubature_with_gaussian_weight.m b/matlab/cubature_with_gaussian_weight.m index d62cc74cf..032ed196f 100644 --- a/matlab/cubature_with_gaussian_weight.m +++ b/matlab/cubature_with_gaussian_weight.m @@ -34,7 +34,7 @@ function [nodes, weights] = cubature_with_gaussian_weight(d,n,method) %! @end deftypefn %@eod: -% Copyright (C) 2012 Dynare Team +% Copyright (C) 2012-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/disp_identification.m b/matlab/disp_identification.m index ccc62ced7..0badae976 100644 --- a/matlab/disp_identification.m +++ b/matlab/disp_identification.m @@ -1,6 +1,6 @@ function disp_identification(pdraws, idemodel, idemoments, name, advanced) -% Copyright (C) 2008-2011 Dynare Team +% Copyright (C) 2008-2012 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/disp_th_moments.m b/matlab/disp_th_moments.m index cf3397a64..6db80e839 100644 --- a/matlab/disp_th_moments.m +++ b/matlab/disp_th_moments.m @@ -1,7 +1,7 @@ function disp_th_moments(dr,var_list) % Display theoretical moments of variables -% Copyright (C) 2001-2011 Dynare Team +% Copyright (C) 2001-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/display_conditional_variance_decomposition.m b/matlab/display_conditional_variance_decomposition.m index ed4f334fc..d0b2e6536 100644 --- a/matlab/display_conditional_variance_decomposition.m +++ b/matlab/display_conditional_variance_decomposition.m @@ -16,7 +16,7 @@ function oo_ = display_conditional_variance_decomposition(Steps, SubsetOfVariabl % [1] The covariance matrix of the state innovations needs to be diagonal. % [2] In this version, absence of measurement errors is assumed... -% Copyright (C) 2010-2012 Dynare Team +% Copyright (C) 2010-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/dr_block.m b/matlab/dr_block.m index 5c9c1b216..fd63743bf 100644 --- a/matlab/dr_block.m +++ b/matlab/dr_block.m @@ -33,7 +33,7 @@ function [dr,info,M_,options_,oo_] = dr_block(dr,task,M_,options_,oo_) % none. % -% Copyright (C) 2010-2012 Dynare Team +% Copyright (C) 2010-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/dsge_likelihood.m b/matlab/dsge_likelihood.m index 7f52229b8..225993af0 100644 --- a/matlab/dsge_likelihood.m +++ b/matlab/dsge_likelihood.m @@ -111,7 +111,7 @@ function [fval,DLIK,Hess,exit_flag,ys,trend_coeff,info,Model,DynareOptions,Bayes %! @end deftypefn %@eod: -% Copyright (C) 2004-2012 Dynare Team +% Copyright (C) 2004-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/dyn_forecast.m b/matlab/dyn_forecast.m index 1804b9a67..bea68db53 100644 --- a/matlab/dyn_forecast.m +++ b/matlab/dyn_forecast.m @@ -16,7 +16,7 @@ function info = dyn_forecast(var_list,task) % SPECIAL REQUIREMENTS % none -% Copyright (C) 2003-2011 Dynare Team +% Copyright (C) 2003-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/dynare.m b/matlab/dynare.m index 56d4a6dc6..acf6c43d2 100644 --- a/matlab/dynare.m +++ b/matlab/dynare.m @@ -16,7 +16,7 @@ function dynare(fname, varargin) % SPECIAL REQUIREMENTS % none -% Copyright (C) 2001-2012 Dynare Team +% Copyright (C) 2001-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/dynare_estimation.m b/matlab/dynare_estimation.m index eb33130ad..4627a54b2 100644 --- a/matlab/dynare_estimation.m +++ b/matlab/dynare_estimation.m @@ -11,7 +11,7 @@ function dynare_estimation(var_list,dname) % SPECIAL REQUIREMENTS % none -% Copyright (C) 2003-2012 Dynare Team +% Copyright (C) 2003-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/dynare_estimation_init.m b/matlab/dynare_estimation_init.m index bf9a7a292..14daf9040 100644 --- a/matlab/dynare_estimation_init.m +++ b/matlab/dynare_estimation_init.m @@ -18,7 +18,7 @@ function [dataset_,xparam1, M_, options_, oo_, estim_params_,bayestopt_, fake] = % SPECIAL REQUIREMENTS % none -% Copyright (C) 2003-2012 Dynare Team +% Copyright (C) 2003-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/dynare_identification.m b/matlab/dynare_identification.m index 9703de917..47d6133fa 100644 --- a/matlab/dynare_identification.m +++ b/matlab/dynare_identification.m @@ -19,7 +19,7 @@ function [pdraws, TAU, GAM, LRE, gp, H, JJ] = dynare_identification(options_iden % main % -% Copyright (C) 2010-2012 Dynare Team +% Copyright (C) 2010-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/dynare_sensitivity.m b/matlab/dynare_sensitivity.m index e098db41d..719cbf02b 100644 --- a/matlab/dynare_sensitivity.m +++ b/matlab/dynare_sensitivity.m @@ -4,7 +4,7 @@ function x0=dynare_sensitivity(options_gsa) % Reference: % M. Ratto, Global Sensitivity Analysis for Macroeconomic models, MIMEO, 2006. -% Copyright (C) 2008-2011 Dynare Team +% Copyright (C) 2008-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/ep/extended_path.m b/matlab/ep/extended_path.m index 7782a53d3..981d84706 100644 --- a/matlab/ep/extended_path.m +++ b/matlab/ep/extended_path.m @@ -14,7 +14,7 @@ function time_series = extended_path(initial_conditions,sample_size) % % SPECIAL REQUIREMENTS -% Copyright (C) 2009-2012 Dynare Team +% Copyright (C) 2009-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/ep/solve_stochastic_perfect_foresight_model.m b/matlab/ep/solve_stochastic_perfect_foresight_model.m index d498e5586..12b8b37cf 100644 --- a/matlab/ep/solve_stochastic_perfect_foresight_model.m +++ b/matlab/ep/solve_stochastic_perfect_foresight_model.m @@ -1,6 +1,6 @@ function [flag,endo_simul,err] = solve_stochastic_perfect_foresight_model(endo_simul,exo_simul,pfm,nnodes,order) -% Copyright (C) 2012 Dynare Team +% Copyright (C) 2012-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/ep/solve_stochastic_perfect_foresight_model_1.m b/matlab/ep/solve_stochastic_perfect_foresight_model_1.m index 54184ef10..f732792e5 100644 --- a/matlab/ep/solve_stochastic_perfect_foresight_model_1.m +++ b/matlab/ep/solve_stochastic_perfect_foresight_model_1.m @@ -1,6 +1,6 @@ function [flag,endo_simul,err] = solve_stochastic_perfect_foresight_model_1(endo_simul,exo_simul,pfm,nnodes,order) -% Copyright (C) 2012 Dynare Team +% Copyright (C) 2012-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/fastgensylv.m b/matlab/fastgensylv.m index 40166673b..332e46f28 100644 --- a/matlab/fastgensylv.m +++ b/matlab/fastgensylv.m @@ -111,19 +111,3 @@ end % % SPECIAL REQUIREMENTS % none. -% Copyright (C) 1996-2012 Dynare Team -% -% This file is part of Dynare. -% -% Dynare is free software: you can redistribute it and/or modify -% it under the terms of the GNU General Public License as published by -% the Free Software Foundation, either version 3 of the License, or -% (at your option) any later version. -% -% Dynare is distributed in the hope that it will be useful, -% but WITHOUT ANY WARRANTY; without even the implied warranty of -% MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -% GNU General Public License for more details. -% -% You should have received a copy of the GNU General Public License -% along with Dynare. If not, see . diff --git a/matlab/forecast_graphs.m b/matlab/forecast_graphs.m index 3731ad3db..f95b77541 100644 --- a/matlab/forecast_graphs.m +++ b/matlab/forecast_graphs.m @@ -1,6 +1,6 @@ function forecast_graphs(var_list) -% Copyright (C) 2008-2012 Dynare Team +% Copyright (C) 2008-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/gauss_hermite_weights_and_nodes.m b/matlab/gauss_hermite_weights_and_nodes.m index 40287cb71..70d5abae4 100644 --- a/matlab/gauss_hermite_weights_and_nodes.m +++ b/matlab/gauss_hermite_weights_and_nodes.m @@ -31,7 +31,7 @@ function [nodes,weights] = gauss_hermite_weights_and_nodes(n) %! @end deftypefn %@eod: -% Copyright (C) 2011 Dynare Team +% Copyright (C) 2011-2012 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/getJJ.m b/matlab/getJJ.m index fab0f0d99..1facc956b 100644 --- a/matlab/getJJ.m +++ b/matlab/getJJ.m @@ -1,6 +1,6 @@ function [JJ, H, gam, gp, dA, dOm, dYss] = getJJ(A, B, M_,oo_,options_,kronflag,indx,indexo,mf,nlags,useautocorr) -% Copyright (C) 2010-2011 Dynare Team +% Copyright (C) 2010-2012 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/global_initialization.m b/matlab/global_initialization.m index b4938047a..4d73624bf 100644 --- a/matlab/global_initialization.m +++ b/matlab/global_initialization.m @@ -11,7 +11,7 @@ function global_initialization() % SPECIAL REQUIREMENTS % none -% Copyright (C) 2003-2012 Dynare Team +% Copyright (C) 2003-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/graph_decomp.m b/matlab/graph_decomp.m index 7afc3d775..f69c8d833 100644 --- a/matlab/graph_decomp.m +++ b/matlab/graph_decomp.m @@ -1,7 +1,7 @@ function []=graph_decomp(z,shock_names,endo_names,i_var,initial_date,DynareModel,DynareOptions) %function []=graph_decomp(z,varlist,initial_period,freq) -% Copyright (C) 2010-2011 Dynare Team +% Copyright (C) 2010-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/gsa/filt_mc_.m b/matlab/gsa/filt_mc_.m index 5b35e919f..5ced8be59 100644 --- a/matlab/gsa/filt_mc_.m +++ b/matlab/gsa/filt_mc_.m @@ -16,7 +16,7 @@ function [rmse_MC, ixx] = filt_mc_(OutDir,options_gsa_,dataset_) % Reference: % M. Ratto, Global Sensitivity Analysis for Macroeconomic models, MIMEO, 2006. -% Copyright (C) 2012 Dynare Team +% Copyright (C) 2012-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/gsa/map_ident_.m b/matlab/gsa/map_ident_.m index 4ca202623..591c547c2 100644 --- a/matlab/gsa/map_ident_.m +++ b/matlab/gsa/map_ident_.m @@ -1,6 +1,6 @@ function map_ident_(OutputDirectoryName,opt_gsa) -% Copyright (C) 2012 Dynare Team +% Copyright (C) 2012-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/gsa/redform_map.m b/matlab/gsa/redform_map.m index d85607066..eb6c8e0cf 100644 --- a/matlab/gsa/redform_map.m +++ b/matlab/gsa/redform_map.m @@ -19,7 +19,7 @@ function redform_map(dirname,options_gsa_) % Reference: % M. Ratto, Global Sensitivity Analysis for Macroeconomic models, MIMEO, 2006. -% Copyright (C) 2012 Dynare Team +% Copyright (C) 2012-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/gsa/redform_screen.m b/matlab/gsa/redform_screen.m index ef8add9f3..cdbd2d596 100644 --- a/matlab/gsa/redform_screen.m +++ b/matlab/gsa/redform_screen.m @@ -14,7 +14,7 @@ function redform_screen(dirname, options_gsa_) % Reference: % M. Ratto, Global Sensitivity Analysis for Macroeconomic models, MIMEO, 2006. -% Copyright (C) 2012 Dynare Team +% Copyright (C) 2012-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/gsa/stab_map_.m b/matlab/gsa/stab_map_.m index 7cc03c53a..de220c3c8 100644 --- a/matlab/gsa/stab_map_.m +++ b/matlab/gsa/stab_map_.m @@ -38,7 +38,7 @@ function x0 = stab_map_(OutputDirectoryName,opt_gsa) % Reference: % M. Ratto, Global Sensitivity Analysis for Macroeconomic models, MIMEO, 2006. -% Copyright (C) 2012 Dynare Team +% Copyright (C) 2012-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/gsa/stab_map_1.m b/matlab/gsa/stab_map_1.m index 34b6b7331..314c3ddc6 100644 --- a/matlab/gsa/stab_map_1.m +++ b/matlab/gsa/stab_map_1.m @@ -24,7 +24,7 @@ function [proba, dproba] = stab_map_1(lpmat, ibehaviour, inonbehaviour, aname, i % Reference: % M. Ratto, Global Sensitivity Analysis for Macroeconomic models, MIMEO, 2006. -% Copyright (C) 2012 Dynare Team +% Copyright (C) 2012-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/gsa/stab_map_2.m b/matlab/gsa/stab_map_2.m index d9363ea60..dcb4bb641 100644 --- a/matlab/gsa/stab_map_2.m +++ b/matlab/gsa/stab_map_2.m @@ -9,7 +9,7 @@ function stab_map_2(x,alpha2, pvalue, fnam, dirname,xparam1,figtitle) % Reference: % M. Ratto, Global Sensitivity Analysis for Macroeconomic models, MIMEO, 2006. -% Copyright (C) 2012 Dynare Team +% Copyright (C) 2012-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/ident_bruteforce.m b/matlab/ident_bruteforce.m index a5f6094b0..57a54984c 100644 --- a/matlab/ident_bruteforce.m +++ b/matlab/ident_bruteforce.m @@ -9,7 +9,7 @@ function [pars, cosnJ] = ident_bruteforce(J,n,TeX, pnames_TeX) % pars : cell array with groupf of params for each column of J for 1 to n % cosnJ : the cosn of each column with the selected group of columns -% Copyright (C) 2009-2011 Dynare Team +% Copyright (C) 2009-2012 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/identification_analysis.m b/matlab/identification_analysis.m index 1e9bda93f..07f5ce50f 100644 --- a/matlab/identification_analysis.m +++ b/matlab/identification_analysis.m @@ -25,7 +25,7 @@ function [ide_hess, ide_moments, ide_model, ide_lre, derivatives_info, info] = i % SPECIAL REQUIREMENTS % None -% Copyright (C) 2008-2012 Dynare Team +% Copyright (C) 2008-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/independent_metropolis_hastings.m b/matlab/independent_metropolis_hastings.m index 8e24ad178..afbe03701 100644 --- a/matlab/independent_metropolis_hastings.m +++ b/matlab/independent_metropolis_hastings.m @@ -22,7 +22,7 @@ function record=independent_metropolis_hastings(TargetFun,ProposalFun,xparam1,vv % PARALLEL CONTEXT % See the comment in random_walk_metropolis_hastings.m funtion. -% Copyright (C) 2006-2011 Dynare Team +% Copyright (C) 2006-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/independent_metropolis_hastings_core.m b/matlab/independent_metropolis_hastings_core.m index 83ec21127..e6c8c3f5e 100644 --- a/matlab/independent_metropolis_hastings_core.m +++ b/matlab/independent_metropolis_hastings_core.m @@ -16,7 +16,7 @@ function myoutput = independent_metropolis_hastings_core(myinputs,fblck,nblck,wh % SPECIAL REQUIREMENTS. % None. % -% Copyright (C) 2006-2011 Dynare Team +% Copyright (C) 2006-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/k_order_perturbation.m b/matlab/k_order_perturbation.m index 566a28117..96b7ba5f6 100644 --- a/matlab/k_order_perturbation.m +++ b/matlab/k_order_perturbation.m @@ -51,3 +51,20 @@ % k_order_peturbation is a compiled MEX function. It's source code is in % dynare/mex/sources/k_order_perturbation.cc and it uses code provided by % dynare++ + +% Copyright (C) 2013 Dynare Team +% +% This file is part of Dynare. +% +% Dynare is free software: you can redistribute it and/or modify +% it under the terms of the GNU General Public License as published by +% the Free Software Foundation, either version 3 of the License, or +% (at your option) any later version. +% +% Dynare is distributed in the hope that it will be useful, +% but WITHOUT ANY WARRANTY; without even the implied warranty of +% MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the +% GNU General Public License for more details. +% +% You should have received a copy of the GNU General Public License +% along with Dynare. If not, see . diff --git a/matlab/kalman/likelihood/kalman_filter.m b/matlab/kalman/likelihood/kalman_filter.m index e04348b78..8dee95f06 100644 --- a/matlab/kalman/likelihood/kalman_filter.m +++ b/matlab/kalman/likelihood/kalman_filter.m @@ -71,7 +71,7 @@ function [LIK, LIKK, a, P] = kalman_filter(Y,start,last,a,P,kalman_tol,riccati_t %! @end deftypefn %@eod: -% Copyright (C) 2004-2012 Dynare Team +% Copyright (C) 2004-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/kalman/likelihood/kalman_filter_d.m b/matlab/kalman/likelihood/kalman_filter_d.m index c90f157fc..ced4d1305 100644 --- a/matlab/kalman/likelihood/kalman_filter_d.m +++ b/matlab/kalman/likelihood/kalman_filter_d.m @@ -31,7 +31,7 @@ function [dLIK,dlik,a,Pstar] = kalman_filter_d(Y, start, last, a, Pinf, Pstar, k % Models", S.J. Koopman and J. Durbin (2003, in Journal of Time Series % Analysis, vol. 24(1), pp. 85-98). -% Copyright (C) 2004-2012 Dynare Team +% Copyright (C) 2004-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/kronecker/A_times_B_kronecker_C.m b/matlab/kronecker/A_times_B_kronecker_C.m index e46306f0f..8e0837d3d 100644 --- a/matlab/kronecker/A_times_B_kronecker_C.m +++ b/matlab/kronecker/A_times_B_kronecker_C.m @@ -43,7 +43,7 @@ function [D, err] = A_times_B_kronecker_C(A,B,C,fake) %! @end deftypefn %@eod: -% Copyright (C) 1996-2011 Dynare Team +% Copyright (C) 1996-2012 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/kronecker/sparse_hessian_times_B_kronecker_C.m b/matlab/kronecker/sparse_hessian_times_B_kronecker_C.m index 09be1b7f9..fd6059f84 100644 --- a/matlab/kronecker/sparse_hessian_times_B_kronecker_C.m +++ b/matlab/kronecker/sparse_hessian_times_B_kronecker_C.m @@ -45,7 +45,7 @@ function [D, err] = sparse_hessian_times_B_kronecker_C(varargin) %! @end deftypefn %@eod: -% Copyright (C) 1996-2011 Dynare Team +% Copyright (C) 1996-2012 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/load_csv_file_data.m b/matlab/load_csv_file_data.m index 8a62ba613..84e7f6a6f 100644 --- a/matlab/load_csv_file_data.m +++ b/matlab/load_csv_file_data.m @@ -38,7 +38,7 @@ function [freq, init, data, varlist] = load_csv_file_data(file, withtime, withna %! @end deftypefn %@eod: -% Copyright (C) 2012 Dynare Team +% Copyright (C) 2012-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/load_m_file_data.m b/matlab/load_m_file_data.m index 30a5d4434..31526f986 100644 --- a/matlab/load_m_file_data.m +++ b/matlab/load_m_file_data.m @@ -32,8 +32,7 @@ function [freq,init,data,varlist,tex] = load_m_file_data(file) %! @end deftypefn %@eod: - -% Copyright (C) 2012, 2013 Dynare Team +% Copyright (C) 2012-2013 Dynare Team % % This file is part of Dynare. % @@ -153,4 +152,4 @@ end %$ t(8) = dyn_assert(data(:,1),[1;2;3;4;5]); %$ t(9) = dyn_assert(data(:,2),[2;3;4;5;6]); %$ T = all(t); -%@eof:1 \ No newline at end of file +%@eof:1 diff --git a/matlab/load_mat_file_data.m b/matlab/load_mat_file_data.m index 01f3f73fb..876cb293d 100644 --- a/matlab/load_mat_file_data.m +++ b/matlab/load_mat_file_data.m @@ -32,8 +32,7 @@ function [freq,init,data,varlist,tex] = load_mat_file_data(file) %! @end deftypefn %@eod: - -% Copyright (C) 2012, 2013 Dynare Team +% Copyright (C) 2012-2013 Dynare Team % % This file is part of Dynare. % @@ -125,4 +124,4 @@ end %$ t(8) = dyn_assert(data(:,1),[1;2;3;4;5]); %$ t(9) = dyn_assert(data(:,2),[2;3;4;5;6]); %$ T = all(t); -%@eof:1 \ No newline at end of file +%@eof:1 diff --git a/matlab/maximize_prior_density.m b/matlab/maximize_prior_density.m index cee0cc394..09cb3d774 100644 --- a/matlab/maximize_prior_density.m +++ b/matlab/maximize_prior_density.m @@ -15,7 +15,7 @@ function [xparams,lpd,hessian] = ... % lpd [double] scalar, value of the logged prior density at the mode. % hessian [double] matrix, Hessian matrix at the prior mode. -% Copyright (C) 2009-2011 Dynare Team +% Copyright (C) 2009-2012 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/metropolis_hastings_initialization.m b/matlab/metropolis_hastings_initialization.m index e56ddcf5f..3e75c78da 100644 --- a/matlab/metropolis_hastings_initialization.m +++ b/matlab/metropolis_hastings_initialization.m @@ -23,7 +23,7 @@ function [ ix2, ilogpo2, ModelName, MhDirectoryName, fblck, fline, npar, nblck, % SPECIAL REQUIREMENTS % None. -% Copyright (C) 2006-2011 Dynare Team +% Copyright (C) 2006-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/mh_autocorrelation_function.m b/matlab/mh_autocorrelation_function.m index a0a479c7c..ff71f38dc 100644 --- a/matlab/mh_autocorrelation_function.m +++ b/matlab/mh_autocorrelation_function.m @@ -18,7 +18,7 @@ function mh_autocorrelation_function(options_,M_,estim_params_,type,blck,name1,n % % SPECIAL REQUIREMENTS -% Copyright (C) 2003-2011 Dynare Team +% Copyright (C) 2003-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/minus_logged_prior_density.m b/matlab/minus_logged_prior_density.m index ef883e005..2697a474b 100644 --- a/matlab/minus_logged_prior_density.m +++ b/matlab/minus_logged_prior_density.m @@ -12,7 +12,7 @@ function [fval,fake_1, fake_2, exit_flag ] = minus_logged_prior_density(xparams, % OUTPUTS % f [double] value of minus the logged prior density. -% Copyright (C) 2009 Dynare Team +% Copyright (C) 2009-2012 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/mode_check.m b/matlab/mode_check.m index 1be56baca..fdbd290b0 100644 --- a/matlab/mode_check.m +++ b/matlab/mode_check.m @@ -40,7 +40,7 @@ function mode_check(fun,x,hessian,DynareDataset,DynareOptions,Model,EstimatedPar %! @end deftypefn %@eod: -% Copyright (C) 2003-2012 Dynare Team +% Copyright (C) 2003-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/ms-sbvar/sbvar.m b/matlab/ms-sbvar/sbvar.m index 3d14a8ae0..00762085d 100644 --- a/matlab/ms-sbvar/sbvar.m +++ b/matlab/ms-sbvar/sbvar.m @@ -15,7 +15,7 @@ function sbvar(M, options) % none. % -% Copyright (C) 2011 Dynare Team +% Copyright (C) 2011-2012 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/newrat.m b/matlab/newrat.m index 7feb73af3..3ce1dbd10 100644 --- a/matlab/newrat.m +++ b/matlab/newrat.m @@ -23,7 +23,7 @@ function [xparam1, hh, gg, fval, igg] = newrat(func0, x, analytic_derivation, ft % % varargin = list of parameters for func0 -% Copyright (C) 2004-2012 Dynare Team +% Copyright (C) 2004-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/non_linear_dsge_likelihood.m b/matlab/non_linear_dsge_likelihood.m index f7656a2cc..326bf297e 100644 --- a/matlab/non_linear_dsge_likelihood.m +++ b/matlab/non_linear_dsge_likelihood.m @@ -101,7 +101,7 @@ function [fval,ys,trend_coeff,exit_flag,info,Model,DynareOptions,BayesInfo,Dynar %! @end deftypefn %@eod: -% Copyright (C) 2010-2012 Dynare Team +% Copyright (C) 2010-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/parallel/AnalyseComputationalEnvironment.m b/matlab/parallel/AnalyseComputationalEnvironment.m index f3bf88c36..6d5d07430 100644 --- a/matlab/parallel/AnalyseComputationalEnvironment.m +++ b/matlab/parallel/AnalyseComputationalEnvironment.m @@ -82,7 +82,7 @@ dynareParallelMkDir(RemoteTmpFolder,DataInput); % Currently when errors are detected execution simply stops and users can % fix configuration errors according to the error type. -% Copyright (C) 2009-2012 Dynare Team +% Copyright (C) 2009-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/parallel/GiveCPUnumber.m b/matlab/parallel/GiveCPUnumber.m index c858d258f..3176bb1a5 100644 --- a/matlab/parallel/GiveCPUnumber.m +++ b/matlab/parallel/GiveCPUnumber.m @@ -13,7 +13,7 @@ function [nCPU]= GiveCPUnumber (ComputerInformations, Environment) % SPECIAL REQUIREMENTS % none -% Copyright (C) 2010-2011 Dynare Team +% Copyright (C) 2010-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/parallel/InitializeComputationalEnvironment.m b/matlab/parallel/InitializeComputationalEnvironment.m index f5bc691a9..22cc49c83 100644 --- a/matlab/parallel/InitializeComputationalEnvironment.m +++ b/matlab/parallel/InitializeComputationalEnvironment.m @@ -10,7 +10,7 @@ function InitializeComputationalEnvironment() % OUTPUTS % None % -% Copyright (C) 2009-2011 Dynare Team +% Copyright (C) 2009-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/parallel/closeSlave.m b/matlab/parallel/closeSlave.m index cb3c84ae4..339d776bb 100644 --- a/matlab/parallel/closeSlave.m +++ b/matlab/parallel/closeSlave.m @@ -15,7 +15,7 @@ function closeSlave(Parallel,TmpFolder,partial), % OUTPUTS % None % -% Copyright (C) 2010-2012 Dynare Team +% Copyright (C) 2010-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/parallel/dynareParallelDelete.m b/matlab/parallel/dynareParallelDelete.m index 403e40e29..7efbff020 100644 --- a/matlab/parallel/dynareParallelDelete.m +++ b/matlab/parallel/dynareParallelDelete.m @@ -11,7 +11,7 @@ function dynareParallelDelete(fname,pname,Parallel) % None % % -% Copyright (C) 2009-2012 Dynare Team +% Copyright (C) 2009-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/parallel/dynareParallelDeleteNewFiles.m b/matlab/parallel/dynareParallelDeleteNewFiles.m index fc0975b13..e28cd77da 100644 --- a/matlab/parallel/dynareParallelDeleteNewFiles.m +++ b/matlab/parallel/dynareParallelDeleteNewFiles.m @@ -15,7 +15,7 @@ function dynareParallelDeleteNewFiles(PRCDir,Parallel,PRCDirSnapshot,varargin) % % % -% Copyright (C) 2009-2012 Dynare Team +% Copyright (C) 2009-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/parallel/dynareParallelDir.m b/matlab/parallel/dynareParallelDir.m index ac8780716..ba31dafe0 100644 --- a/matlab/parallel/dynareParallelDir.m +++ b/matlab/parallel/dynareParallelDir.m @@ -10,7 +10,7 @@ function dirlist = dynareParallelDir(filename,PRCDir,Parallel) % OUTPUTS % o dirlist [] ... % -% Copyright (C) 2009-2011 Dynare Team +% Copyright (C) 2009-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/parallel/dynareParallelGetFiles.m b/matlab/parallel/dynareParallelGetFiles.m index 531594bee..bfffaf972 100644 --- a/matlab/parallel/dynareParallelGetFiles.m +++ b/matlab/parallel/dynareParallelGetFiles.m @@ -14,7 +14,7 @@ function dynareParallelGetFiles(NamFileInput,PRCDir,Parallel) % % % -% Copyright (C) 2009-2011 Dynare Team +% Copyright (C) 2009-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/parallel/dynareParallelGetNewFiles.m b/matlab/parallel/dynareParallelGetNewFiles.m index be9a08f8e..5f7eb43a3 100644 --- a/matlab/parallel/dynareParallelGetNewFiles.m +++ b/matlab/parallel/dynareParallelGetNewFiles.m @@ -15,7 +15,7 @@ function [PRCDirSnapshot]=dynareParallelGetNewFiles(PRCDir,Parallel,PRCDirSnapsh % % % -% Copyright (C) 2009-2012 Dynare Team +% Copyright (C) 2009-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/parallel/dynareParallelListAllFiles.m b/matlab/parallel/dynareParallelListAllFiles.m index 8a51b13c6..53e893e15 100644 --- a/matlab/parallel/dynareParallelListAllFiles.m +++ b/matlab/parallel/dynareParallelListAllFiles.m @@ -14,7 +14,7 @@ function fileList = dynareParallelListAllFiles(dirName,PRCDir,Parallel) % OUTPUTS % o fileList [] ... % -% Copyright (C) 2009-2011 Dynare Team +% Copyright (C) 2009-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/parallel/dynareParallelMkDir.m b/matlab/parallel/dynareParallelMkDir.m index 1698113a7..7ebde3819 100644 --- a/matlab/parallel/dynareParallelMkDir.m +++ b/matlab/parallel/dynareParallelMkDir.m @@ -10,7 +10,7 @@ function dynareParallelMkDir(PRCDir,Parallel) % None % % -% Copyright (C) 2009-2011 Dynare Team +% Copyright (C) 2009-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/parallel/dynareParallelRmDir.m b/matlab/parallel/dynareParallelRmDir.m index 2bba6bc5c..6322f9b8a 100644 --- a/matlab/parallel/dynareParallelRmDir.m +++ b/matlab/parallel/dynareParallelRmDir.m @@ -11,7 +11,7 @@ function dynareParallelRmDir(PRCDir,Parallel) % % % -% Copyright (C) 2009-2012 Dynare Team +% Copyright (C) 2009-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/parallel/dynareParallelSendFiles.m b/matlab/parallel/dynareParallelSendFiles.m index a1a857ae4..b1dc9cc28 100644 --- a/matlab/parallel/dynareParallelSendFiles.m +++ b/matlab/parallel/dynareParallelSendFiles.m @@ -14,7 +14,7 @@ function dynareParallelSendFiles(NamFileInput,PRCDir,Parallel) % % % -% Copyright (C) 2009-2011 Dynare Team +% Copyright (C) 2009-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/parallel/masterParallel.m b/matlab/parallel/masterParallel.m index df3afa033..a7c2b7082 100644 --- a/matlab/parallel/masterParallel.m +++ b/matlab/parallel/masterParallel.m @@ -53,7 +53,7 @@ function [fOutVar,nBlockPerCPU, totCPU] = masterParallel(Parallel,fBlock,nBlock, % the number of CPU declared in "Parallel", if % the number of required threads is lower) -% Copyright (C) 2009-2012 Dynare Team +% Copyright (C) 2009-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/particle/conditional_particle_filter.m b/matlab/particle/conditional_particle_filter.m index 7969013ab..05b725534 100644 --- a/matlab/particle/conditional_particle_filter.m +++ b/matlab/particle/conditional_particle_filter.m @@ -37,7 +37,7 @@ function [LIK,lik] = conditional_particle_filter(ReducedForm,Y,start,DynareOptio % % NOTES % The vector "lik" is used to evaluate the jacobian of the likelihood. -% Copyright (C) 2009-2010 Dynare Team +% Copyright (C) 2009-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/particle/fit_gaussian_mixture.m b/matlab/particle/fit_gaussian_mixture.m index 2ae2089ea..e4c8e4c5d 100644 --- a/matlab/particle/fit_gaussian_mixture.m +++ b/matlab/particle/fit_gaussian_mixture.m @@ -1,4 +1,22 @@ function [StateMu,StateSqrtP,StateWeights] = fit_gaussian_mixture(X,StateMu,StateSqrtP,StateWeights,crit,niters,check) + +% Copyright (C) 2013 Dynare Team +% +% This file is part of Dynare. +% +% Dynare is free software: you can redistribute it and/or modify +% it under the terms of the GNU General Public License as published by +% the Free Software Foundation, either version 3 of the License, or +% (at your option) any later version. +% +% Dynare is distributed in the hope that it will be useful, +% but WITHOUT ANY WARRANTY; without even the implied warranty of +% MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the +% GNU General Public License for more details. +% +% You should have received a copy of the GNU General Public License +% along with Dynare. If not, see . + [dim,Ndata] = size(X); M = size(StateMu,2) ; if check % Ensure that covariances don't collapse diff --git a/matlab/particle/gaussian_densities.m b/matlab/particle/gaussian_densities.m index 3a770118d..0c89f0862 100644 --- a/matlab/particle/gaussian_densities.m +++ b/matlab/particle/gaussian_densities.m @@ -19,7 +19,7 @@ function IncrementalWeights = gaussian_densities(obs,mut_t,sqr_Pss_t_t,st_t_1,sq % % NOTES % The vector "lik" is used to evaluate the jacobian of the likelihood. -% Copyright (C) 2009-2010 Dynare Team +% Copyright (C) 2009-2012 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/particle/gaussian_filter_bank.m b/matlab/particle/gaussian_filter_bank.m index fc0639042..41cd6aa02 100644 --- a/matlab/particle/gaussian_filter_bank.m +++ b/matlab/particle/gaussian_filter_bank.m @@ -19,7 +19,7 @@ function [PredictedStateMean,PredictedStateVarianceSquareRoot,StateVectorMean,St % % NOTES % The vector "lik" is used to evaluate the jacobian of the likelihood. -% Copyright (C) 2009-2010 Dynare Team +% Copyright (C) 2009-2012 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/particle/importance_sampling.m b/matlab/particle/importance_sampling.m index a0c527757..403b6beb3 100644 --- a/matlab/particle/importance_sampling.m +++ b/matlab/particle/importance_sampling.m @@ -1,4 +1,22 @@ function State_Particles = importance_sampling(StateMuPost,StateSqrtPPost,StateWeightsPost,numP) + +% Copyright (C) 2013 Dynare Team +% +% This file is part of Dynare. +% +% Dynare is free software: you can redistribute it and/or modify +% it under the terms of the GNU General Public License as published by +% the Free Software Foundation, either version 3 of the License, or +% (at your option) any later version. +% +% Dynare is distributed in the hope that it will be useful, +% but WITHOUT ANY WARRANTY; without even the implied warranty of +% MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the +% GNU General Public License for more details. +% +% You should have received a copy of the GNU General Public License +% along with Dynare. If not, see . + [Xdim,Gsecond] = size(StateMuPost) ; u = rand(numP,1); [Nc,comp] = histc(u, cumsum([0; StateWeightsPost])); diff --git a/matlab/particle/local_state_space_iteration/local_state_space_iteration_2.m b/matlab/particle/local_state_space_iteration/local_state_space_iteration_2.m index 778e2d075..bc205d180 100644 --- a/matlab/particle/local_state_space_iteration/local_state_space_iteration_2.m +++ b/matlab/particle/local_state_space_iteration/local_state_space_iteration_2.m @@ -58,7 +58,7 @@ function [y,y_] = local_state_space_iteration_2(yhat,epsilon,ghx,ghu,constant,gh %! @end deftypefn %@eod: -% Copyright (C) 2011, 2012 Dynare Team +% Copyright (C) 2011-2012 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/particle/measurement_equations.m b/matlab/particle/measurement_equations.m index abcc4da7c..c00d8ebc4 100644 --- a/matlab/particle/measurement_equations.m +++ b/matlab/particle/measurement_equations.m @@ -1,4 +1,22 @@ function measure = measurement_equations(StateVectors,ReducedForm,DynareOptions) + +% Copyright (C) 2013 Dynare Team +% +% This file is part of Dynare. +% +% Dynare is free software: you can redistribute it and/or modify +% it under the terms of the GNU General Public License as published by +% the Free Software Foundation, either version 3 of the License, or +% (at your option) any later version. +% +% Dynare is distributed in the hope that it will be useful, +% but WITHOUT ANY WARRANTY; without even the implied warranty of +% MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the +% GNU General Public License for more details. +% +% You should have received a copy of the GNU General Public License +% along with Dynare. If not, see . + mf1 = ReducedForm.mf1; ghx = ReducedForm.ghx(mf1,:); ghu = ReducedForm.ghu(mf1,:); diff --git a/matlab/particle/mykmeans.m b/matlab/particle/mykmeans.m index 0be651936..56af5390b 100644 --- a/matlab/particle/mykmeans.m +++ b/matlab/particle/mykmeans.m @@ -1,4 +1,22 @@ function [c,SqrtVariance,Weights] = mykmeans(x,g,init,cod) + +% Copyright (C) 2013 Dynare Team +% +% This file is part of Dynare. +% +% Dynare is free software: you can redistribute it and/or modify +% it under the terms of the GNU General Public License as published by +% the Free Software Foundation, either version 3 of the License, or +% (at your option) any later version. +% +% Dynare is distributed in the hope that it will be useful, +% but WITHOUT ANY WARRANTY; without even the implied warranty of +% MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the +% GNU General Public License for more details. +% +% You should have received a copy of the GNU General Public License +% along with Dynare. If not, see . + [n,m] = size(x) ; indold = zeros(1,m) ; if cod==0 @@ -32,4 +50,4 @@ for i=1:g u = bsxfun(@minus,temp,mean(temp,2)); %temp-mean(temp,1)' ; SqrtVariance(:,:,i) = chol( (u*u')/size(temp,2) )' ; Weights(i) = size(temp,2)/m ; -end \ No newline at end of file +end diff --git a/matlab/particle/neff.m b/matlab/particle/neff.m index 84fefffac..5251b9f17 100644 --- a/matlab/particle/neff.m +++ b/matlab/particle/neff.m @@ -1,4 +1,21 @@ function n = neff(w) % Evaluates the criterion for resampling -n = dot(w,w); \ No newline at end of file +% Copyright (C) 2013 Dynare Team +% +% This file is part of Dynare. +% +% Dynare is free software: you can redistribute it and/or modify +% it under the terms of the GNU General Public License as published by +% the Free Software Foundation, either version 3 of the License, or +% (at your option) any later version. +% +% Dynare is distributed in the hope that it will be useful, +% but WITHOUT ANY WARRANTY; without even the implied warranty of +% MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the +% GNU General Public License for more details. +% +% You should have received a copy of the GNU General Public License +% along with Dynare. If not, see . + +n = dot(w,w); diff --git a/matlab/particle/probability.m b/matlab/particle/probability.m index c451ea762..5d76e49ee 100644 --- a/matlab/particle/probability.m +++ b/matlab/particle/probability.m @@ -1,4 +1,22 @@ function [prior,likelihood,C,posterior] = probability(mu,sqrtP,prior,X) + +% Copyright (C) 2013 Dynare Team +% +% This file is part of Dynare. +% +% Dynare is free software: you can redistribute it and/or modify +% it under the terms of the GNU General Public License as published by +% the Free Software Foundation, either version 3 of the License, or +% (at your option) any later version. +% +% Dynare is distributed in the hope that it will be useful, +% but WITHOUT ANY WARRANTY; without even the implied warranty of +% MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the +% GNU General Public License for more details. +% +% You should have received a copy of the GNU General Public License +% along with Dynare. If not, see . + [dim,nov] = size(X); M = size(mu,2) ; if nargout>1 diff --git a/matlab/particle/probability2.m b/matlab/particle/probability2.m index b253ba928..57ab65f8f 100644 --- a/matlab/particle/probability2.m +++ b/matlab/particle/probability2.m @@ -14,7 +14,7 @@ function [density] = probability2(mu,S,X) % % NOTES % -% Copyright (C) 2009-2011 Dynare Team +% Copyright (C) 2009-2012 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/particle/spherical_radial_sigma_points.m b/matlab/particle/spherical_radial_sigma_points.m index 70eadb109..754caacfa 100644 --- a/matlab/particle/spherical_radial_sigma_points.m +++ b/matlab/particle/spherical_radial_sigma_points.m @@ -15,7 +15,7 @@ function [nodes,weights] = spherical_radial_sigma_points(n) % % NOTES % -% Copyright (C) 2009-2010 Dynare Team +% Copyright (C) 2009-2012 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/plot_icforecast.m b/matlab/plot_icforecast.m index 98ad52b39..6284769fa 100644 --- a/matlab/plot_icforecast.m +++ b/matlab/plot_icforecast.m @@ -10,7 +10,7 @@ function plot_icforecast(Variables,periods,options_) % SPECIAL REQUIREMENTS % This routine has to be called after imcforecast.m. -% Copyright (C) 2006-2012 Dynare Team +% Copyright (C) 2006-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/plot_identification.m b/matlab/plot_identification.m index 4cc2d3a88..b37129510 100644 --- a/matlab/plot_identification.m +++ b/matlab/plot_identification.m @@ -18,7 +18,7 @@ function plot_identification(params,idemoments,idehess,idemodel, idelre, advance % SPECIAL REQUIREMENTS % None -% Copyright (C) 2008-2012 Dynare Team +% Copyright (C) 2008-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/pm3.m b/matlab/pm3.m index 91ec283ed..09488aa5e 100644 --- a/matlab/pm3.m +++ b/matlab/pm3.m @@ -4,7 +4,7 @@ function pm3(n1,n2,ifil,B,tit1,tit2,tit3,tit_tex,names1,names2,name3,DirectoryNa % See also the comment in random_walk_metropolis_hastings.m funtion. -% Copyright (C) 2007-2012 Dynare Team +% Copyright (C) 2007-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/prior_bounds.m b/matlab/prior_bounds.m index 623c79263..2d187c9a5 100644 --- a/matlab/prior_bounds.m +++ b/matlab/prior_bounds.m @@ -48,7 +48,7 @@ function bounds = prior_bounds(bayestopt,options) % SPECIAL REQUIREMENTS % none -% Copyright (C) 2003-2011 Dynare Team +% Copyright (C) 2003-2012 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/priordens.m b/matlab/priordens.m index 5844d3c17..ddc6fa92f 100644 --- a/matlab/priordens.m +++ b/matlab/priordens.m @@ -14,7 +14,7 @@ function [logged_prior_density, dlprior, d2lprior] = priordens(x, pshape, p6, p7 % logged_prior_density [double] scalar, log of the prior density evaluated at x. % -% Copyright (C) 2003-2011 Dynare Team +% Copyright (C) 2003-2012 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/qr2.m b/matlab/qr2.m index de429f36a..3c84db996 100644 --- a/matlab/qr2.m +++ b/matlab/qr2.m @@ -17,7 +17,7 @@ function [Q,R] = qr2(varargin) % SPECIAL REQUIREMENTS % None. -% Copyright (C) 2006-2009 Dynare Team +% Copyright (C) 2006-2012 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/random_walk_metropolis_hastings.m b/matlab/random_walk_metropolis_hastings.m index 1c75e2102..f64603f69 100644 --- a/matlab/random_walk_metropolis_hastings.m +++ b/matlab/random_walk_metropolis_hastings.m @@ -39,7 +39,7 @@ function record=random_walk_metropolis_hastings(TargetFun,ProposalFun,xparam1,vv % Then the comments write here can be used for all the other pairs of % parallel functions and also for management funtions. -% Copyright (C) 2006-2011 Dynare Team +% Copyright (C) 2006-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/random_walk_metropolis_hastings_core.m b/matlab/random_walk_metropolis_hastings_core.m index f47e97262..fa1b771d2 100644 --- a/matlab/random_walk_metropolis_hastings_core.m +++ b/matlab/random_walk_metropolis_hastings_core.m @@ -47,7 +47,7 @@ function myoutput = random_walk_metropolis_hastings_core(myinputs,fblck,nblck,wh % parallel functions and also for management funtions. -% Copyright (C) 2006-2011 Dynare Team +% Copyright (C) 2006-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/rplot.m b/matlab/rplot.m index d8f8c39be..50cda1bca 100644 --- a/matlab/rplot.m +++ b/matlab/rplot.m @@ -14,7 +14,7 @@ function rplot(s1) % SPECIAL REQUIREMENTS % none -% Copyright (C) 2001-2009 Dynare Team +% Copyright (C) 2001-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/set_all_parameters.m b/matlab/set_all_parameters.m index 14815a3d9..656ac34ed 100644 --- a/matlab/set_all_parameters.m +++ b/matlab/set_all_parameters.m @@ -33,7 +33,7 @@ function M = set_all_parameters(xparam1,estim_params,M) %! @end deftypefn %@eod: -% Copyright (C) 2003-2012 Dynare Team +% Copyright (C) 2003-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/setup_stochastic_perfect_foresight_model_solver.m b/matlab/setup_stochastic_perfect_foresight_model_solver.m index a085db978..616281783 100644 --- a/matlab/setup_stochastic_perfect_foresight_model_solver.m +++ b/matlab/setup_stochastic_perfect_foresight_model_solver.m @@ -1,4 +1,21 @@ function pfm = setup_stochastic_perfect_foresight_model_solver(DynareModel,DynareOptions,DynareOutput,IntegrationMethod) + +% Copyright (C) 2013 Dynare Team +% +% This file is part of Dynare. +% +% Dynare is free software: you can redistribute it and/or modify +% it under the terms of the GNU General Public License as published by +% the Free Software Foundation, either version 3 of the License, or +% (at your option) any later version. +% +% Dynare is distributed in the hope that it will be useful, +% but WITHOUT ANY WARRANTY; without even the implied warranty of +% MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the +% GNU General Public License for more details. +% +% You should have received a copy of the GNU General Public License +% along with Dynare. If not, see . pfm.lead_lag_incidence = DynareModel.lead_lag_incidence; pfm.ny = DynareModel.endo_nbr; @@ -82,4 +99,4 @@ if nargin>3 && DynareOptions.ep.stochastic.order otherwise error('setup_stochastic_perfect_foresight_model_solver:: Unknown integration algorithm!') end -end \ No newline at end of file +end diff --git a/matlab/sim1.m b/matlab/sim1.m index ed305dd70..35b5318b8 100644 --- a/matlab/sim1.m +++ b/matlab/sim1.m @@ -13,7 +13,7 @@ function sim1() % SPECIAL REQUIREMENTS % None. -% Copyright (C) 1996-2012 Dynare Team +% Copyright (C) 1996-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/sim1_purely_backward.m b/matlab/sim1_purely_backward.m index a561c4195..30e640971 100644 --- a/matlab/sim1_purely_backward.m +++ b/matlab/sim1_purely_backward.m @@ -1,7 +1,7 @@ function sim1_purely_backward() % Performs deterministic simulation of a purely backward model -% Copyright (C) 2012 Dynare Team +% Copyright (C) 2012-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/simul.m b/matlab/simul.m index 9fbab7e41..007a0d77b 100644 --- a/matlab/simul.m +++ b/matlab/simul.m @@ -12,7 +12,7 @@ function simul() % SPECIAL REQUIREMENTS % none -% Copyright (C) 1996-2012 Dynare Team +% Copyright (C) 1996-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/simult_.m b/matlab/simult_.m index d2b948a97..86c38cc92 100644 --- a/matlab/simult_.m +++ b/matlab/simult_.m @@ -15,7 +15,7 @@ function y_=simult_(y0,dr,ex_,iorder) % SPECIAL REQUIREMENTS % none -% Copyright (C) 2001-2012 Dynare Team +% Copyright (C) 2001-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/step_length_correction.m b/matlab/step_length_correction.m index 7334aa2d6..8950bc764 100644 --- a/matlab/step_length_correction.m +++ b/matlab/step_length_correction.m @@ -1,6 +1,24 @@ function c = step_length_correction(x,scale,i) + +% Copyright (C) 2013 Dynare Team +% +% This file is part of Dynare. +% +% Dynare is free software: you can redistribute it and/or modify +% it under the terms of the GNU General Public License as published by +% the Free Software Foundation, either version 3 of the License, or +% (at your option) any later version. +% +% Dynare is distributed in the hope that it will be useful, +% but WITHOUT ANY WARRANTY; without even the implied warranty of +% MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the +% GNU General Public License for more details. +% +% You should have received a copy of the GNU General Public License +% along with Dynare. If not, see . + if isempty(scale) c = 10^round(log10(abs(x))); else c = scale(i); - end \ No newline at end of file + end diff --git a/matlab/stoch_simul.m b/matlab/stoch_simul.m index e06b413bb..8102750aa 100644 --- a/matlab/stoch_simul.m +++ b/matlab/stoch_simul.m @@ -1,6 +1,6 @@ function info=stoch_simul(var_list) -% Copyright (C) 2001-2012 Dynare Team +% Copyright (C) 2001-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/stochastic_solvers.m b/matlab/stochastic_solvers.m index c420bc99c..5e7a2ae1c 100644 --- a/matlab/stochastic_solvers.m +++ b/matlab/stochastic_solvers.m @@ -29,7 +29,7 @@ function [dr,info] = stochastic_solvers(dr,task,M_,options_,oo_) % none. % -% Copyright (C) 1996-2012 Dynare Team +% Copyright (C) 1996-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/thet2tau.m b/matlab/thet2tau.m index 2fedb0806..b3db2c683 100644 --- a/matlab/thet2tau.m +++ b/matlab/thet2tau.m @@ -1,7 +1,7 @@ function tau = thet2tau(params, M_, oo_, indx, indexo, flagmoments,mf,nlags,useautocorr,iv) % -% Copyright (C) 2011 Dynare Team +% Copyright (C) 2011-2012 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/utilities/dataset/compute_acov.m b/matlab/utilities/dataset/compute_acov.m index a67f24e48..b1834e854 100644 --- a/matlab/utilities/dataset/compute_acov.m +++ b/matlab/utilities/dataset/compute_acov.m @@ -36,7 +36,7 @@ function dataset_ = compute_acov(dataset_) %! @end deftypefn %@eod: -% Copyright (C) 2011 Dynare Team +% Copyright (C) 2011-2012 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/utilities/dataset/compute_corr.m b/matlab/utilities/dataset/compute_corr.m index d4a81dc07..d6469baef 100644 --- a/matlab/utilities/dataset/compute_corr.m +++ b/matlab/utilities/dataset/compute_corr.m @@ -33,7 +33,7 @@ function dataset_ = compute_corr(dataset_) %! @end deftypefn %@eod: -% Copyright (C) 2011 Dynare Team +% Copyright (C) 2011-2012 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/utilities/dataset/compute_cova.m b/matlab/utilities/dataset/compute_cova.m index cde46848f..51f68981e 100644 --- a/matlab/utilities/dataset/compute_cova.m +++ b/matlab/utilities/dataset/compute_cova.m @@ -30,7 +30,7 @@ function dataset_ = compute_cova(dataset_) %! @end deftypefn %@eod: -% Copyright (C) 2011 Dynare Team +% Copyright (C) 2011-2012 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/utilities/dataset/compute_stdv.m b/matlab/utilities/dataset/compute_stdv.m index 2ddbbfc01..4384f83dd 100644 --- a/matlab/utilities/dataset/compute_stdv.m +++ b/matlab/utilities/dataset/compute_stdv.m @@ -30,7 +30,7 @@ function dataset_ = compute_stdv(dataset_) %! @end deftypefn %@eod: -% Copyright (C) 2011 Dynare Team +% Copyright (C) 2011-2012 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/utilities/dataset/describe_missing_data.m b/matlab/utilities/dataset/describe_missing_data.m index 421e64d83..5506da2be 100644 --- a/matlab/utilities/dataset/describe_missing_data.m +++ b/matlab/utilities/dataset/describe_missing_data.m @@ -27,7 +27,7 @@ function [i,n,s,j] = describe_missing_data(data) %! @end deftypefn %@eod: -% Copyright (C) 2008-2011 Dynare Team +% Copyright (C) 2008-2012 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/utilities/dataset/descriptive_statistics.m b/matlab/utilities/dataset/descriptive_statistics.m index 35981246e..d2b52292d 100644 --- a/matlab/utilities/dataset/descriptive_statistics.m +++ b/matlab/utilities/dataset/descriptive_statistics.m @@ -45,7 +45,7 @@ function dataset_ = descriptive_statistics(dataset_,statistic,varagin) %! @end deftypefn %@eod: -% Copyright (C) 2011 Dynare Team +% Copyright (C) 2011-2012 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/utilities/dataset/initialize_dataset.m b/matlab/utilities/dataset/initialize_dataset.m index 5ba5b11a5..979ad1f55 100644 --- a/matlab/utilities/dataset/initialize_dataset.m +++ b/matlab/utilities/dataset/initialize_dataset.m @@ -1,7 +1,7 @@ function dataset_ = initialize_dataset(datafile,varobs,first,nobs,transformation,prefilter,xls) % Initializes a structure describing the dataset. -% Copyright (C) 2011 Dynare Team +% Copyright (C) 2011-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/utilities/doc/dynInfo.m b/matlab/utilities/doc/dynInfo.m index c52e8efce..3c20d0e77 100644 --- a/matlab/utilities/doc/dynInfo.m +++ b/matlab/utilities/doc/dynInfo.m @@ -31,7 +31,7 @@ function dynInfo(fun) %! @end deftypefn %@eod: -% Copyright (C) 2011 Dynare Team +% Copyright (C) 2011-2012 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/utilities/doc/get_internal_doc_block.m b/matlab/utilities/doc/get_internal_doc_block.m index d965500fe..718b2a28d 100644 --- a/matlab/utilities/doc/get_internal_doc_block.m +++ b/matlab/utilities/doc/get_internal_doc_block.m @@ -1,7 +1,7 @@ function block = get_internal_doc_block(fname,fpath) % Extract doc sections from matlab's routine. -% Copyright (C) 2011 Dynare Team +% Copyright (C) 2011-2012 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/utilities/general/demean.m b/matlab/utilities/general/demean.m index 332ab100d..4bf53aaa6 100644 --- a/matlab/utilities/general/demean.m +++ b/matlab/utilities/general/demean.m @@ -27,7 +27,7 @@ function c = demean(x) %! @end deftypefn %@eod: -% Copyright (C) 2011 Dynare Team +% Copyright (C) 2011-2012 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/utilities/general/iscellofchar.m b/matlab/utilities/general/iscellofchar.m index a79c770f0..80193464e 100644 --- a/matlab/utilities/general/iscellofchar.m +++ b/matlab/utilities/general/iscellofchar.m @@ -1,6 +1,6 @@ function a = iscellofchar(b) -% Copyright (C) 2012 Dynare Team +% Copyright (C) 2012-2013 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/utilities/general/ndim.m b/matlab/utilities/general/ndim.m index f9e2c80df..1c4d003bb 100644 --- a/matlab/utilities/general/ndim.m +++ b/matlab/utilities/general/ndim.m @@ -27,7 +27,7 @@ function n = ndim(x) %! @end deftypefn %@eod: -% Copyright (C) 2011 Dynare Team +% Copyright (C) 2011-2012 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/utilities/tests/dyn_assert.m b/matlab/utilities/tests/dyn_assert.m index c6b017081..531163139 100644 --- a/matlab/utilities/tests/dyn_assert.m +++ b/matlab/utilities/tests/dyn_assert.m @@ -1,7 +1,7 @@ function t = dyn_assert(A,B,tol) % This function tests the equality of two objects. -% Copyright (C) 2011 Dynare Team +% Copyright (C) 2011-2012 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/utilities/tests/mtest.m b/matlab/utilities/tests/mtest.m index 1354deaed..f12e4d9ff 100644 --- a/matlab/utilities/tests/mtest.m +++ b/matlab/utilities/tests/mtest.m @@ -1,7 +1,7 @@ function check = mtest(fname,fpath) % Extract test sections from matlab's routine executes the test and report errors. -% Copyright (C) 2011 Dynare Team +% Copyright (C) 2011-2012 Dynare Team % % This file is part of Dynare. % diff --git a/matlab/variance_decomposition_mc_analysis.m b/matlab/variance_decomposition_mc_analysis.m index 4b5d9a966..b4f3f570d 100644 --- a/matlab/variance_decomposition_mc_analysis.m +++ b/matlab/variance_decomposition_mc_analysis.m @@ -2,7 +2,7 @@ function oo_ = variance_decomposition_mc_analysis(NumberOfSimulations,type,dname % This function analyses the (posterior or prior) distribution of the % endogenous variance decomposition. -% Copyright (C) 2008-2009 Dynare Team +% Copyright (C) 2008-2013 Dynare Team % % This file is part of Dynare. % diff --git a/mex/sources/block_kalman_filter/block_kalman_filter.cc b/mex/sources/block_kalman_filter/block_kalman_filter.cc index e8741cf66..6104feb12 100644 --- a/mex/sources/block_kalman_filter/block_kalman_filter.cc +++ b/mex/sources/block_kalman_filter/block_kalman_filter.cc @@ -1,5 +1,5 @@ /* - * Copyright (C) 2007-2012 Dynare Team + * Copyright (C) 2007-2013 Dynare Team * * This file is part of Dynare. * diff --git a/mex/sources/block_kalman_filter/block_kalman_filter.h b/mex/sources/block_kalman_filter/block_kalman_filter.h index 501e3820b..98803e024 100644 --- a/mex/sources/block_kalman_filter/block_kalman_filter.h +++ b/mex/sources/block_kalman_filter/block_kalman_filter.h @@ -1,5 +1,5 @@ /* - * Copyright (C) 2007-2011 Dynare Team + * Copyright (C) 2007-2012 Dynare Team * * This file is part of Dynare. * diff --git a/mex/sources/bytecode/ErrorHandling.hh b/mex/sources/bytecode/ErrorHandling.hh index d7759de51..fe6047c88 100644 --- a/mex/sources/bytecode/ErrorHandling.hh +++ b/mex/sources/bytecode/ErrorHandling.hh @@ -1,5 +1,5 @@ /* - * Copyright (C) 2007-2012 Dynare Team + * Copyright (C) 2007-2013 Dynare Team * * This file is part of Dynare. * diff --git a/mex/sources/bytecode/Evaluate.cc b/mex/sources/bytecode/Evaluate.cc index b53dc12f9..74be26bf3 100644 --- a/mex/sources/bytecode/Evaluate.cc +++ b/mex/sources/bytecode/Evaluate.cc @@ -1,3 +1,22 @@ +/* + * Copyright (C) 2013 Dynare Team + * + * This file is part of Dynare. + * + * Dynare is free software: you can redistribute it and/or modify + * it under the terms of the GNU General Public License as published by + * the Free Software Foundation, either version 3 of the License, or + * (at your option) any later version. + * + * Dynare is distributed in the hope that it will be useful, + * but WITHOUT ANY WARRANTY; without even the implied warranty of + * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the + * GNU General Public License for more details. + * + * You should have received a copy of the GNU General Public License + * along with Dynare. If not, see . + */ + #include #include #include diff --git a/mex/sources/bytecode/Evaluate.hh b/mex/sources/bytecode/Evaluate.hh index 4d95b0428..33621b7a4 100644 --- a/mex/sources/bytecode/Evaluate.hh +++ b/mex/sources/bytecode/Evaluate.hh @@ -1,5 +1,5 @@ /* - * Copyright (C) 2007-2012 Dynare Team + * Copyright (C) 2007-2013 Dynare Team * * This file is part of Dynare. * diff --git a/mex/sources/bytecode/Interpreter.cc b/mex/sources/bytecode/Interpreter.cc index 91aeffdfc..522f71890 100644 --- a/mex/sources/bytecode/Interpreter.cc +++ b/mex/sources/bytecode/Interpreter.cc @@ -1,5 +1,5 @@ /* - * Copyright (C) 2007-2012 Dynare Team + * Copyright (C) 2007-2013 Dynare Team * * This file is part of Dynare. * diff --git a/mex/sources/bytecode/Interpreter.hh b/mex/sources/bytecode/Interpreter.hh index b33b608d8..4c00e9f9b 100644 --- a/mex/sources/bytecode/Interpreter.hh +++ b/mex/sources/bytecode/Interpreter.hh @@ -1,5 +1,5 @@ /* - * Copyright (C) 2007-2012 Dynare Team + * Copyright (C) 2007-2013 Dynare Team * * This file is part of Dynare. * diff --git a/mex/sources/bytecode/SparseMatrix.hh b/mex/sources/bytecode/SparseMatrix.hh index ef76a60b7..48e4ed1c0 100644 --- a/mex/sources/bytecode/SparseMatrix.hh +++ b/mex/sources/bytecode/SparseMatrix.hh @@ -1,5 +1,5 @@ /* - * Copyright (C) 2007-2012 Dynare Team + * Copyright (C) 2007-2013 Dynare Team * * This file is part of Dynare. * diff --git a/mex/sources/bytecode/bytecode.cc b/mex/sources/bytecode/bytecode.cc index c56f97b9c..56ec734fd 100644 --- a/mex/sources/bytecode/bytecode.cc +++ b/mex/sources/bytecode/bytecode.cc @@ -1,5 +1,5 @@ /* - * Copyright (C) 2007-2012 Dynare Team + * Copyright (C) 2007-2013 Dynare Team * * This file is part of Dynare. * diff --git a/mex/sources/dynblas.h b/mex/sources/dynblas.h index ba159ae12..47e365ea0 100644 --- a/mex/sources/dynblas.h +++ b/mex/sources/dynblas.h @@ -8,7 +8,7 @@ * and MATLAB_VERSION (for version 7.4, define it to 0x0704). * * - * Copyright (C) 2009-2011 Dynare Team + * Copyright (C) 2009-2013 Dynare Team * * This file is part of Dynare. * diff --git a/mex/sources/estimation/tests/DsgeLikelihood.m b/mex/sources/estimation/tests/DsgeLikelihood.m index 6de151c6d..a39358065 100644 --- a/mex/sources/estimation/tests/DsgeLikelihood.m +++ b/mex/sources/estimation/tests/DsgeLikelihood.m @@ -21,7 +21,7 @@ function [fval,cost_flag,ys,trend_coeff,info] = DsgeLikelihood(xparam1,gend,data % SPECIAL REQUIREMENTS % -% Copyright (C) 2004-2010 Dynare Team +% Copyright (C) 2004-2012 Dynare Team % % This file is part of Dynare. % diff --git a/mex/sources/k_order_perturbation/k_ord_dynare.hh b/mex/sources/k_order_perturbation/k_ord_dynare.hh index 445373cdc..8465f8c47 100644 --- a/mex/sources/k_order_perturbation/k_ord_dynare.hh +++ b/mex/sources/k_order_perturbation/k_ord_dynare.hh @@ -1,5 +1,5 @@ /* - * Copyright (C) 2008-2010 Dynare Team + * Copyright (C) 2008-2012 Dynare Team * * This file is part of Dynare. * diff --git a/mex/sources/kalman_steady_state/kalman_steady_state.cc b/mex/sources/kalman_steady_state/kalman_steady_state.cc index 74588aad4..8ae89372e 100644 --- a/mex/sources/kalman_steady_state/kalman_steady_state.cc +++ b/mex/sources/kalman_steady_state/kalman_steady_state.cc @@ -1,6 +1,6 @@ /* kalman_steady_state.cc ** -** Copyright (C) 2009-2011 Dynare Team. +** Copyright (C) 2009-2013 Dynare Team. ** ** This file is part of Dynare. ** diff --git a/mex/sources/local_state_space_iterations/local_state_space_iteration_2.cc b/mex/sources/local_state_space_iterations/local_state_space_iteration_2.cc index 131ad2d8e..de78ff2e4 100644 --- a/mex/sources/local_state_space_iterations/local_state_space_iteration_2.cc +++ b/mex/sources/local_state_space_iterations/local_state_space_iteration_2.cc @@ -1,5 +1,5 @@ /* - * Copyright (C) 2010-2012 Dynare Team + * Copyright (C) 2010-2013 Dynare Team * * This file is part of Dynare. * diff --git a/mex/sources/ms-sbvar/modify_for_mex.cc b/mex/sources/ms-sbvar/modify_for_mex.cc index 521497272..4a6d74db9 100644 --- a/mex/sources/ms-sbvar/modify_for_mex.cc +++ b/mex/sources/ms-sbvar/modify_for_mex.cc @@ -1,5 +1,5 @@ /* - * Copyright (C) 2010-2011 Dynare Team + * Copyright (C) 2010-2013 Dynare Team * * This file is part of Dynare. * diff --git a/mex/sources/ordschur/ordschur.cc b/mex/sources/ordschur/ordschur.cc index dbd7e3b81..8289bba56 100644 --- a/mex/sources/ordschur/ordschur.cc +++ b/mex/sources/ordschur/ordschur.cc @@ -8,7 +8,7 @@ */ /* - * Copyright (C) 2010-2011 Dynare Team + * Copyright (C) 2010-2012 Dynare Team * * This file is part of Dynare. * diff --git a/mex/sources/qzcomplex/qzcomplex.cc b/mex/sources/qzcomplex/qzcomplex.cc index 4241bf529..cfd13cfa7 100644 --- a/mex/sources/qzcomplex/qzcomplex.cc +++ b/mex/sources/qzcomplex/qzcomplex.cc @@ -6,7 +6,7 @@ */ /* - * Copyright (C) 2010-2011 Dynare Team + * Copyright (C) 2010-2012 Dynare Team * * This file is part of Dynare. * diff --git a/preprocessor/ConfigFile.cc b/preprocessor/ConfigFile.cc index 72260b34b..0a3ef5eed 100644 --- a/preprocessor/ConfigFile.cc +++ b/preprocessor/ConfigFile.cc @@ -1,5 +1,5 @@ /* - * Copyright (C) 2010-2012 Dynare Team + * Copyright (C) 2010-2013 Dynare Team * * This file is part of Dynare. * diff --git a/preprocessor/DynamicModel.cc b/preprocessor/DynamicModel.cc index 2dfba144b..6b562b48f 100644 --- a/preprocessor/DynamicModel.cc +++ b/preprocessor/DynamicModel.cc @@ -1,5 +1,5 @@ /* - * Copyright (C) 2003-2012 Dynare Team + * Copyright (C) 2003-2013 Dynare Team * * This file is part of Dynare. * diff --git a/preprocessor/DynamicModel.hh b/preprocessor/DynamicModel.hh index 63ac665f4..808dccaa7 100644 --- a/preprocessor/DynamicModel.hh +++ b/preprocessor/DynamicModel.hh @@ -1,5 +1,5 @@ /* - * Copyright (C) 2003-2012 Dynare Team + * Copyright (C) 2003-2013 Dynare Team * * This file is part of Dynare. * diff --git a/preprocessor/ModelTree.cc b/preprocessor/ModelTree.cc index b6f3fd3ac..2a798017c 100644 --- a/preprocessor/ModelTree.cc +++ b/preprocessor/ModelTree.cc @@ -1,5 +1,5 @@ /* - * Copyright (C) 2003-2012 Dynare Team + * Copyright (C) 2003-2013 Dynare Team * * This file is part of Dynare. * diff --git a/preprocessor/ModelTree.hh b/preprocessor/ModelTree.hh index 4800ccc92..3a29aa90e 100644 --- a/preprocessor/ModelTree.hh +++ b/preprocessor/ModelTree.hh @@ -1,5 +1,5 @@ /* - * Copyright (C) 2003-2011 Dynare Team + * Copyright (C) 2003-2013 Dynare Team * * This file is part of Dynare. * diff --git a/preprocessor/NumericalConstants.cc b/preprocessor/NumericalConstants.cc index dc2bd80f2..a2224eae4 100644 --- a/preprocessor/NumericalConstants.cc +++ b/preprocessor/NumericalConstants.cc @@ -1,5 +1,5 @@ /* - * Copyright (C) 2003-2011 Dynare Team + * Copyright (C) 2003-2012 Dynare Team * * This file is part of Dynare. * diff --git a/preprocessor/NumericalConstants.hh b/preprocessor/NumericalConstants.hh index cb50b0cb4..1b4be7446 100644 --- a/preprocessor/NumericalConstants.hh +++ b/preprocessor/NumericalConstants.hh @@ -1,5 +1,5 @@ /* - * Copyright (C) 2003-2011 Dynare Team + * Copyright (C) 2003-2012 Dynare Team * * This file is part of Dynare. * diff --git a/preprocessor/NumericalInitialization.cc b/preprocessor/NumericalInitialization.cc index 1c26d74f5..4e28a4920 100644 --- a/preprocessor/NumericalInitialization.cc +++ b/preprocessor/NumericalInitialization.cc @@ -1,5 +1,5 @@ /* - * Copyright (C) 2003-2012 Dynare Team + * Copyright (C) 2003-2013 Dynare Team * * This file is part of Dynare. * diff --git a/preprocessor/StaticModel.hh b/preprocessor/StaticModel.hh index 8f7735b32..f193c4c4d 100644 --- a/preprocessor/StaticModel.hh +++ b/preprocessor/StaticModel.hh @@ -1,5 +1,5 @@ /* - * Copyright (C) 2003-2011 Dynare Team + * Copyright (C) 2003-2012 Dynare Team * * This file is part of Dynare. * diff --git a/tests/internals/tests.m b/tests/internals/tests.m index 54b139871..14b3a778c 100644 --- a/tests/internals/tests.m +++ b/tests/internals/tests.m @@ -1,6 +1,6 @@ % matlab script for testing matlab routines. -% Copyright (C) 2011 Dynare Team +% Copyright (C) 2011-2012 Dynare Team % % This file is part of Dynare. % diff --git a/tests/measurement_errors/fs2000_corr_me_ml_mcmc/fs2000_corr_ME_steadystate.m b/tests/measurement_errors/fs2000_corr_me_ml_mcmc/fs2000_corr_ME_steadystate.m index 66a95e6ef..916373fee 100644 --- a/tests/measurement_errors/fs2000_corr_me_ml_mcmc/fs2000_corr_ME_steadystate.m +++ b/tests/measurement_errors/fs2000_corr_me_ml_mcmc/fs2000_corr_ME_steadystate.m @@ -1,7 +1,7 @@ % computes the steady state of fs2000 analyticaly % largely inspired by the program of F. Schorfheide -% Copyright (C) 2004-2010 Dynare Team +% Copyright (C) 2004-2013 Dynare Team % % This file is part of Dynare. %