< Master index Index for . >

Index for .

Matlab files in this directory:

 CheckPath06-03-2005
 CreateBenchmarkstephane.adjemian@cepremap.cnrs.fr [12-06-2004]
 CutSamplestephane.adjemian@ens.fr [09-09-2005]
 DiffuseKalmanSmoother1modified by M. Ratto:
 DiffuseKalmanSmoother3function [a,etahat,a1, aK] = DiffuseKalmanSmoother3(T,R,Q,Pinf1,Pstar1,Y,trend,pp,mm,smpl,mf)
 DiffuseKalmanSmootherH1modified by M. Ratto:
 DiffuseKalmanSmootherH3Modified by M. Ratto
 DiffuseKalmanSmootherH3corrstephane.adjemian@cepremap.cnrs.fr [09-16-2004]
 DiffuseLikelihood1M. Ratto added lik in output
 DiffuseLikelihood3M. Ratto added lik in output [October 2005]
 DiffuseLikelihoodH1M. Ratto added lik in output
 DiffuseLikelihoodH3M. Ratto added lik in output [October 2005]
 DiffuseLikelihoodH3corrstephane.adjemian@cepremap.cnrs.fr [12-13-2004]
 DsgeLikelihoodstephane.adjemian@cepremap.cnrs.fr [09-07-2004]
 DsgeSmootherstephane.adjemian@cepremap.cnrs.fr [09-07-2004]
 GetAllPosteriorDrawsstephane.adjemian@ens.fr [09-09-2005]
 GetOneDrawstephane.adjemian@ens.fr [09-25-2005]
 GetPosteriorParametersStatisticsstephane.adjemian@ens.fr [09-09-2005]
 InitSeedstephane.adjemian@cepremap.cnrs.fr [12-02-2004]
 LPTAU
 MakeAllFiguresstephane.adjemian@cepremap.cnrs.fr [02-04-2005]
 McMCDiagnosticsstephane.adjemian@ens.fr [06-04-2005]
 PlotPosteriorDistributionsstephane.adjemian@ens.fr [09-09-2005]
 PosteriorIRFstephane.adjemian@ens.fr [09-25-2005]
 PosteriorSmootherstephane.adjemian@ens.fr [09-25-2005]
 ReshapeMatFilesReshape and sort (along the mcmc simulations) the mat files generated
 UnivariateSpectralDensitystephane.adjemian@ens.fr
 asaminASAMIN A gateway function to Adaptive Simulated Annealing (ASA) MEX
 beta_rndPURPOSE: random draws from the beta(a,b) distribution
 bfgsiH = bfgsi(H0,dg,dx)
 bicgstab
 bksupCopyright (C) 2001 Michel Juillard
 bksup1Copyright (C) 2001 Michel Juillard
 bksupk
 bseastrCopyright (C) 2001 Michel Juillard
 calib
 calib_objtargets and iy order: 1) variances 2) correlations
 calib_obj2targets and iy order: 1) variances 2) correlations
 checkCopyright (C) 2001 Michel Juillard
 check_mh
 check_model
 compDist
 csminit[fhat,xhat,fcount,retcode] = csminit(fcn,x0,f0,g0,badg,H0,...
 csminwel[fhat,xhat,ghat,Hhat,itct,fcount,retcodehat] = csminwel(fcn,x0,H0,grad,crit,nit,varargin)
 cumplotfunction h =cumplot(x)
 datatomfileCopyright (C) 2001 Michel Juillard
 dbetaDBETA The beta density function
 dcompareCopyright (C) 2001 Michel Juillard
 dgammaDGAMMA The gamma density function
 disp_drCopyright (C) 2001 Michel Juillard
 disp_momentsCopyright (C) 2001 Michel Juillard
 disp_th_momentsCopyright (C) 2001 Michel Juillard
 dlognormDLOGNORM The log-normal density function
 dnormDNORM The normal density function
 dr1Copyright (C) 2001 Michel Juillard
 dr11Copyright (C) 2001 Michel Juillard
 dr2Copyright (C) 2001 Michel Juillard
 draw_prior_densitystephane.adjemian@ens.fr [07-15-2004]
 dsampleCopyright (C) 2001 Michel Juillard
 dy_date
 dyn2vecCopyright (C) 2001 Michel Juillard
 dynareCopyright (C) 2001 Michel Juillard
 dynare_MC
 dynare_estimation
 dynare_resolve
 dynare_sensitivitycopyright Marco Ratto 2006
 dynare_solveCopyright (C) 2001 Michel Juillard
 dynasaveCopyright (C) 2001 Michel Juillard
 dynatypeCopyright (C) 2001 Michel Juillard
 f_var
 fbetamust restrict p2 such that a>0 and b>0 ....
 ff1_Copyright (C) 2001 Michel Juillard
 ffillCopyright (C) 2001 Michel Juillard
 fgamma
 figamm
 filt_mc_copyright Marco Ratto 2006
 fnorm
 forcst
 ftestCopyright (C) 2001 Michel Juillard
 gamm_rndPURPOSE: a matrix of random draws from the gamma distribution
 gcompareCopyright (C) 2001 Michel Juillard
 gendata[y,epsilon,alpha,eta] = gendata(T, ssf, a0)
 generalized_choleskyproc gmchol(A);
 generalized_cholesky2/*
 get_the_namestephane.adjemian@cepremap.cnrs.fr [07-13-2004]
 global_initialization
 hessianCopyright (C) 2001 Michel Juillard
 hessian_sparseCopyright (C) 2001 Michel Juillard%% computes second order partial derivatives% uses Abramowitz and Stegun (1965) formulas 25.3.24 and 25.3.27 p. 884function hessian_mat = hessian_sparse(func,x,varargin)global options_func = str2func(func);n=size(x,1);%h1=max(abs(x),options_.gstep*ones(n,1))*eps^(1/3);h1=max(abs(x),sqrt(options_.gstep)*ones(n,1))*eps^(1/6);h_1=h1;xh1=x+h1;h1=xh1-x;xh1=x-h_1;h_1=x-xh1;xh1=x;f0=feval(func,x,varargin{:});nf = size(f0,1);f1=zeros(nf,n);f_1=f1;for i=1:n xh1(i)=x(i)+h1(i); f1(:,i)=feval(func,xh1,varargin{:}); xh1(i)=x(i)-h_1(i); f_1(:,i)=feval(func,xh1,varargin{:}); xh1(i)=x(i); i=i+1;endxh_1=xh1;hessian_mat = spalloc(nf,n*n,3*nf*n);for i=1:n if i > 1 k=[i:n:n*(i-1)]; hessian_mat(:,(i-1)*n+1:(i-1)*n+i-1)=hessian_mat(:,k); end hessian_mat(:,(i-1)*n+i)=sparse((f1(:,i)+f_1(:,i)-2*f0)./(h1(i)*h_1(i))); temp=f1+f_1-f0*ones(1,n); for j=i+1:n xh1(i)=x(i)+h1(i); xh1(j)=x(j)+h_1(j); xh_1(i)=x(i)-h1(i); xh_1(j)=x(j)-h_1(j); hessian_mat(:,(i-1)*n+j)=sparse(-(-feval(func,xh1,varargin{:})-feval(func,xh_1,varargin{:})+temp(:,i)+temp(:,j))./(2*h1(i)*h_1(j))); xh1(i)=x(i); xh1(j)=x(j); xh_1(i)=x(i); xh_1(j)=x(j); j=j+1; end i=i+1;end% 10/03/02 MJ used the 7 points formula
 indnvCopyright (C) 2001 Michel Juillard
 initial_estimation_checks
 initvalf_
 inverse_gamma_specification
 irf
 kalman_filterSYNOPSIS MEX
 kalman_smootherSYNOPSIS MEX
 kalman_transition_matrixmakes transition matrices out of ghx and ghu for Kalman filter
 kernel_density_estimate% This function aims at estimating a continuous density. A kernel density
 lnsrchCopyright (C) 2001 Michel Juillard
 lnsrch1Copyright (C) 2001 Michel Juillard
 lpdfbetalog BETA PDF
 lpdfgamlog GAMMA PDF
 lpdfgbetalog (generalized) BETA PDF
 lpdfig1log INVERSE GAMMA (type 1)
 lpdfig2log INVERSE GAMMA (type 2)
 lpdfnormLPDFNORM The log of the normal density function
 lptauSEQ[lpmat] = lptauSEQ(Nsam,Nvar)
 lyapunov_symmsolves x-a*x*a'=b for b (and then x) symmetrical
 make_ex_Copyright (C) 2001 Michel Juillard
 make_y_Copyright (C) 2001 Michel Juillard
 marginal_densitystephane.adjemian@ens.fr [09-09-2005]
 matrictintfunction w=matrictint(S,XXi,T)
 mcompareCopyright (C) 2001 Michel Juillard
 metropolisstephane.adjemian@ens.fr [09-02-2005]
 metropolis_draw
 mgnldnstyfunction w=mgnldnsty(ydata,lags,xdata,breaks,lambda,mu,mnprior,vprior,train,flat)
 mh_optimal_bandwidth% This function gives the optimal bandwidth parameter of a kernel estimator
 mj_qgammaMJ_QGAMMA The gamma inverse distribution function
 mode_check
 mr_gstepCopyright (C) 2005 Marco Ratto
 mr_hessianCopyright (C) 2004 Marco Ratto
 my_ordeig
 my_subplotspreads subplots on several figures according to a maximum number of
 newrat
 numgradfunction [g badg] = numgrad(fcn,xvarargin)
 olrCopyright (C) 2001 Michel Juillard
 olr1Copyright (C) 2001 Michel Juillard
 olr2Copyright (C) 2003 Michel Juillard
 osrCopyright (C) 2001 Michel Juillard
 osr1
 osr_objthe beginning and the end of this function may be adapted by the userx
 p2toperc
 pgammaPGAMMA The gamma distribution function
 plot_priorsstephane.adjemian@cepremap.cnrs.fr [07-31-2004]
 pltorgstephane.adjemian@cepremap.cnrs.fr [06-07-2004]
 pnormPNORM The normal distribution function
 posterior_density_estimate%
 posterior_distributionstephane.adjemian@cepremap.cnrs.fr [07-15-2004]
 posterior_momentsstephane.adjemian@ens.fr [09-09-2005]
 print_infoCopyright (C) 2005 Michel Juillard
 prior_bounds
 priordensThis procedure computes a prior density for
 qbetaQBETA The beta inverse distribution function
 qchisqQCHISQ The chisquare inverse distribution function
 qgammaQGAMMA The gamma inverse distribution function
 qnormQNORM The normal inverse distribution function
 qzdivfrom Chris Sims web site
 qzswitchfrom Chris Sims web site
 read_variablesCopyright (C) 2005 Michel Juillard
 recursive_momentsstephane.adjemian@cepremap.cnrs.fr [02-03-2005]
 residCopyright (C) 2001 Michel Juillard
 resolCopyright (C) 2001 Michel Juillard
 resol1Copyright (C) 2001 Michel Juillard
 rfvar3function var=rfvar3(ydata,lags,xdata,breaks,lambda,mu)
 rndprior
 rows
 rplotCopyright (C) 2001 Michel Juillard
 sec2hmsfunction [hour, minute, second] = sec2hms(sec)
 selifCopyright (C) 2001 Michel Juillard
 set_all_parameters
 set_default_option
 set_parameters
 set_prior
 set_shocksCopyright (C) 2003 Michel Juillard
 set_state_spaceCopyright (C) 2001 Michel Juillard
 sim1Copyright (C) 2001 Michel Juillard
 simkCopyright (C) 2001 Michel Juillard
 simulCopyright (C) 2001 Michel Juillard
 simultCopyright (C) 2001 Michel Juillard
 simult_Copyright (C) 2001 Michel Juillard
 smirnovSmirnov test for 2 distributions
 solve1Copyright (C) 2001 Michel Juillard
 stab_map_
 stab_map_1function [proba, dproba] = stab_map_1(lpmat, ibehaviour, inonbehaviour, aname, iplot, ipar, dirname)
 stab_map_2function stab_map_2(x,alpha2,istab,fnam)
 stab_map_marginalfunction stab_map_1(lpmat, ibehaviour, inonbehaviour, aname, ipar, dirname)
 steadyCopyright (C) 2001 Michel Juillard
 steady_Copyright (C) 2001 Michel Juillard
 stoch_simulCopyright (C) 2001 Michel Juillard
 sylvester3solves a*x+b*x*c=d
 sylvester3asolves iteratively ax+bxc=d
 tableCopyright (C) 2002 Michel Juillard
 th_autocovariancesCopyright (C) 2001 Michel Juillard
 transition_matrixmakes transition matrices out of ghx and ghu
 uniform_specificationCopyright (C) 2004 Michel Juillard
 union
 varpriorfunction [ydum,xdum,breaks]=varprior(nv,nx,lags,mnprior,vprior)

Subsequent directories:

Dependency Graph


Generated on Fri 16-Jun-2006 09:08:58 by m2html © 2003