MATLAB & Practical Application on Climate Variability Studies EXERCISES

Size: px
Start display at page:

Download "MATLAB & Practical Application on Climate Variability Studies EXERCISES"

Transcription

1 B.Aires, 20-24/02/06 - Centro de Investigaciones del Mar y la Atmosfera & Department of Atmospheric and Oceanic Sciences (UBA) DAY3 Exercise n. 9 Aim: Compute Mean, Standard Deviation for U wind component field DO_mean_and_std.m & Zonal Mean DO_zonal_mean.m Data:..esercizi\day_3\ Data\ uwnd3.mon.mean.nc Solution: DO_mean_and_std.m % Performs means, std, % and zonal mean of U velocity. %%%%%%%%%%%%%%%%%% %% Load 3d U wind component for the period clear all; load coast lati=lat;clear lat;loni=long;clear long; filenamein = '../Data/uwnd3.mon.mean.nc'; % Input file name. nomevar='uwnd'; % Variable name. f = netcdf(filenamein,'r'); % f is the netcdf object. var1 = f{nomevar}; % var1 is the ncvar object. autoscale(var1,0); u=var1(505:624,:,:,:); ncload(filenamein,'level','lat','lon'); u=u.* ; %% Calculate MEAN and STD in time u_10y=squeeze(mean(u)); u_10y_std=squeeze(std(u)); %% Plot U MEAN and U STD at 1000 mb [x,y]=meshgrid(lon,lat); miniu=round(min(min((u_10y(1,:,:))))); maxiu=round(max(max((u_10y(1,:,:))))); figure project1; pcolorm(y,x,squeeze(u_10y(1,:,:))); caxis([miniu maxiu]); cmap=colormap(jet(maxiu-miniu)); cmap(find([miniu:maxiu]==0),:)=1; % set no-autoscaling in reading data. [Line12] % Load the u component % for the period % 120x17x73x144 % Load level, lat, lon % Scale factor & offset % N.B. comment this line if % you want autoscaling (and % set autoscale(var1,1) in % line12. % 17x73x144 % 17x73x144 % set N. of colors. % set to white the 1

2 shading interp colorbar('horiz'); [c,h]=contourm(y,x,squeeze(u_10y(1,:,:)),[miniu:2.5:maxiu],'b'); ht=clabel(c,h,'fontsize',8); set(ht,'color','k'); plotm(lati,loni,'color','k','linewidth',2.5); title('u1000 MEAN years [m/s]','fontweight','bold'); print -djpeg90./output/uwnd_1000mb_mean_ jpg % first value > 0 exercise 9. miniu_std=round(min(min((u_10y_std(1,:,:))))); maxiu_std=round(max(max((u_10y_std(1,:,:))))); figure project1; pcolorm(y,x,squeeze(u_10y_std(1,:,:))); caxis([miniu_std maxiu_std]); cmap=colormap(jet(2*(maxiu_std-miniu_std))); % set N. of colors. shading interp colorbar('horiz'); [c,h]=contourm(y,x,squeeze(u_10y_std(1,:,:)),[miniu_std:1:maxiu_std],'k'); ht=clabel(c,h,'fontsize',8); set(ht,'color','k'); plotm(lati,loni,'color','k','linewidth',2.5); title('u1000 STD years [m/s]','fontweight','bold'); print -djpeg90./output/uwnd_1000mb_std_ jpg 2

3 DO_zonal_mean.m exercise 9. % Performs means, std, % and zonal mean of U velocity. %%%%%%%%%%%%%%%%%% %% Load 3d U wind component for the period clear all; load coast lati=lat;clear lat;loni=long;clear long; filenamein = '../Data/uwnd3.mon.mean.nc'; % Input file name. nomevar='uwnd'; % Variable name. f = netcdf(filenamein,'r'); % f is the netcdf object. var1 = f{nomevar}; % var1 is the ncvar object. autoscale(var1,0); u=var1(505:624,:,:,:); ncload(filenamein,'level','lat','lon'); u=u.* ; % set no-autoscaling in reading data. [Line12] % Load the u component % for the period % 120x17x73x144 % Load level, lat, lon % Scale factor & offset % N.B. comment this line if % you want autoscaling (and % set autoscale(var1,1) in % line12. %% Calculate MEAN and STD in time u_10y=squeeze(mean(u)); % 17x73x144 %% Calculate zonal mean and interpolate in Z. u_10y_zm=squeeze(mean(u_10y,3)); % 17x73 u_10y_zm=u_10y_zm(1:10,:); % Select levels % from 1000 to x73 level2=flipud([200:20:1000]'); % set YI = 1000:20:200 u_10y_zm_i=interp2... % ZI = INTERP2(X,Y,Z,XI,YI) (lat, level(1:10), u_10y_zm, lat,level2'); %% Plot U ZONAL MEAN u_10y_zm_i_p=flipdim(u_10y_zm_i,2); lat_p=flipud(lat); figure pcolor(u_10y_zm_i_p); % flipdim because % lat is 90 : -90 % and we need -90 : 90 set(gca,'xtick',[1:6:73],'xticklabel',lat_p(1:6:)); set(gca,'ytick',[1:5:41],'yticklabel',level2(1:5:)); xlabel('latitude [deg N]');ylabel('Pressure [mb]'); title('u zonal mean Period ','fontweight','bold'); shading interp; hold on; miniu=round(min(u_10y_zm_i_p(:))); maxiu=round(max(u_10y_zm_i_p(:))); caxis([miniu maxiu]); cmap=colormap(jet(maxiu-miniu)); cmap(1:find([miniu:maxiu]==0)-1,:)=1; colorbar('horiz'); %%% Labels for contours <=0 -- %%% % set N. of colors. % set to white the % values < 0 3

4 [cs h]=contour(u_10y_zm_i_p,[miniu:2:0 0],'k--'); hcs=clabel(cs,h,'labelspacing',720,'fontsize',8); %%% Labels for contours >0 - %%% [cs1 h1]=contour(u_10y_zm_i_p,[0:2:maxiu],'k-'); hcs1=clabel(cs1,h1,'labelspacing',720,'fontsize',8); %%% Equatorial line. line([37 37],[0 41],'color','k','linewidth',1.5); print -djpeg90./output/uwnd_zonal_mean_ jpg exercise 9. 4

5 Exercise n. 10 Aim: Correlation maps nino3 Sea Level Pressure & Filtering. Data:...esercizi/day_1/ex2/output/ssta_nino3_30y.dat...esercizi/day_3/Data/slp.25x25.????.mat Solution: DO_ccmap.m % Performs correlation maps, applying a filter to a 30y mm time series. clear all; close all; %%%%%%%%%%%%%%%%%%%%%%%%%%% % Settings... filter = 'yes'; filter_type = 'HP' dataset = [ ' ' ]; dt = 12 resol = [145 73]; itt = 360; in1= [ '../../day_1/ex2/output/ssta_nino3_30y.dat' ]; in2 = [ '..\Data\slp.25x25.' ]; % 'yes','no' % 'HP', 'LP', 'BP' % N of data for each year. % Resolution % Time series length % Input ssta nino3 time series % Input 2D field switch filter case 'yes' out1 = [ './output/hcm_ninio3' filter_type '-SLP' ] % Output plot case 'no' out1 = [ './output/hcm_ninio3-raw-slp' ] % of settings % Grid 2.5 x 2.5 alatg = [ -90:2.5:90 ]; along = [ 0:2.5:360 ]; [axllon,axllat]=meshgrid(along,alatg); %%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%% % Reading the time serie % and the bidimensional field fid=fopen(in1,'r','b'); % Read nino3 ssta 30y tserie=fread(fid,'float32'); % time series in binary format % stored at the of the Exe-2. field=[ ]; for it=1970:1:1999 % Read slp mm fields year=num2str(it); load( [ in2 year '.mat' ] ) % 12x73x145 slp=permute(slp,[ ]); % 73x145x12 slp=reshape(slp,resol(2)*resol(1),12); % 10585x12 field=[ field slp ]; % 10585x360 5

6 exercise 10. % Filtering... switch filter case 'yes' [tserie]=filtering(tserie,filter_type,dt); % Doing correlations... field=field'; nn=resol(1)*resol(2); for n=1:nn [CC(n,1), PVAL1(n,1)] = corr(field(:,n),tserie(:,1)); % CC --> 10585x1 CC1=reshape(CC,resol(2),resol(1)); % CC1 --> 173x145 maxcc1=max(max(cc1)) mincc1=min(min(cc1)) % Plotting % Pannels title... titstr=cell(size(1:2)); switch filter case 'yes' titstr{1} = [ 'HCM, Ninio3-SLP, ' filter_type ', ' dataset ]; titstr{2} = [ 'HCM, Ninio3-SLP (sign at 0.05), ' filter_type ', ' dataset ]; case 'no' titstr{1} = [ 'HCM, Ninio3-SLP-RAW, ' dataset ]; titstr{2} = [ 'HCM, Ninio3-SLP-RAW (sign at 0.05), ' dataset ]; % Plotting HCM... a4 mn=-0.7; % Set Color Axis mx=0.7; % and nco=14; % number of palette colors. % top pannel subplot(211); map_global title ( titstr{1} ); % Shading h=pcolorm(axllat,axllon,cc1(:,:)); caxis([mn mx]); colormap(jet(nco)); colorbar('horizon'); shading interp % zero hold on; [c3,h3]=contourm(axllat,axllon,cc1(:,:),[ 0 0 ],'k'); set(h3,'linestyle','-','linewidth',1.2,'visible','on') hold on; % load coast plotm(lat,long,'k') hold on; %%%%%%%% Significant correlations... % if PVAL <= 0.05 then CC is significant (differs from zero)... % then, introduce NaNs if CC is not significant: ind1 = find( PVAL1(:,1) > 0.05); 6

7 exercise 10. CC(ind1,1)=NaN; CC1m=reshape(CC,resol(2),resol(1)); maxcc1m=max(max(cc1m)) mincc1m=min(min(cc1m)) % Bottom pannel subplot(212) map_global title ( titstr{2} ); % Shading h=pcolorm(axllat,axllon,cc1m(:,:)); caxis([mn mx]); colormap(jet(nco)); colorbar('horizon'); load coast plotm(lat,long,'k') hold on; print('-djpeg100',[ out1 '.jpeg']); return % 10585x1 7

8 Exercise n. 11 Aim: Compute and plot ACW Hovmoeller. Data:...esercizi/day_3/Data/SST_ T42.grd Solution: DO_Hov_ACW.m % Perform ACW Hovmoeller % Use icontourf, ecolorbar & bluewhitered additional functions. %% Set values for reading grd file. [info ctl file needed]. clear in='../data/sst_ t42.grd'; % HadISST1.1 SST data % Period resol = [128 64]; % Resolution itt = 216; % Time series length type='direct'; % 'direct' or 'sequential' undef= ; lon=[0: :360]; % lon & lat.. from ctl lon=lon(1:-1); lat=[ ]; [X,Y]=meshgrid(lon,lat); %% Load HadISST1.1 SST grd data [fid,message]=fopen(in,'r','b'); [var]=read_grd(fid,type,resol(1),resol(2),itt); fclose(fid); %%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%% %% Weight by cos(lat) fcos=cos(y(:,:)*3.14/180); fcos=fcos'; fcos=reshape(fcos,resol(1)*resol(2),1); for it=1:itt var(:,it)=var(:,it).*fcos(:,1); %% undef -> nan var(var==undef)=nan; %% calculate anomaly sst=reshape(var,resol(1),resol(2),itt); % 128x64x216 sst=permute(sst,[2 1 3]); % 64x128x216 sst56s=squeeze(sst(12,:,:)); % lat(12)= ~= -56 % 128x216 sst56s_m=reshape(sst56s,resol(1),12,itt/12); % 128x12x18 sst56s_clima=nanmean(sst56s_m,3); % 128x12 8

9 % N.B. replace nanmean with % local function 'nanmeann' if % you are running on MATLAB 6 sst56s_clima_r=repmat(sst56s_clima,[1 1 18]); % 128x12x18 sst56s_anoma=sst56s_m-sst56s_clima_r; % 128x12x18 sst56s_anoma_r=reshape(sst56s_anoma,resol(1),12*itt/12); % 128x216 exercise 11. %% band pass filtering 3-7 months [b,a] = butter(1,[ 1/7 1/3 ],'stop'); y=filter(b,a,sst56s_anoma_r); %% Plot ACW Hovmoeller mini_c=-1; maxi_c=1; a4 icontourf(y',[mini_c:0.05:maxi_c],'none'); set(gca,'ytick',[1:12:216]); set(gca,'yticklabel',[1982:1:1999]); set(gca,'xtick',[1:16:128]); set(gca,'xticklabel',lon(1:16:)); ylabel('time [years]','fontweight','bold'); xlabel('longitude','fontweight','bold'); % y' to have lon in x % and time in y. colormap(bluewhitered); % Use bluewhitered colorbar, % see the bluewhitered.m fun. ecolorbar([mini_c:0.05:maxi_c]); % N.B. replace this line with the following, % using MATLAB 6. %colorbar; set(gca,'position',[ ]) title('interannual Anomalies along 56 Sud HadISST'...,'fontweight','bold'); print -djpeg90./output/acw_hovmoeller_ jpg 9

10 Exercise n. 12 Aim: 2D Field Interpolation on regular grids DO_interp2.m irregular grids DO_griddata.m Data:..esercizi/day_1/data/skt.mon.mean.nc Solutions: DO_interp2.m % Perform interpolation between different regular grids. clear filenamein = '../../day_1/data/skt.mon.mean.nc'; f = netcdf(filenamein,'nowrite'); var1= f{'skt'}; skt_grid1=var1(1,:,:); % Get the first time step % of the NCEP SKT series % 94x192. lat_grid1=f{'lat'}(:); % Get the lat [94] lon_grid1=f{'lon'}(:); % and lon [192] vectors %% Interp. SKT field on a T30 gaussian grid -> ZI = INTERP2(X,Y,Z,XI,YI) [lon_grid2,lat_grid2]=gridcoord('t30'); % Load lat,lon vectors - res. T30 skt_grid2 = interp2(lon_grid1',lat_grid1,... % 192,94 skt_grid1,... % 94x192 lon_grid2,lat_grid2'); % 96,48 %% Plotting [xlon_grid1,xlat_grid1]=meshgrid(lon_grid1,lat_grid1); [xlon_grid2,xlat_grid2]=meshgrid(lon_grid2,lat_grid2); load coast; mini=round(min(skt_grid1(:))); maxi=round(max(skt_grid1(:))); cmap=colormap(jet(round(maxi-mini))); figure subplot(211); project1; pcolorm(xlat_grid1,xlon_grid1,skt_grid1); plotm(lat,long,'k'); caxis([mini maxi]); title('skt jan 1948 on NCEP Data GRID 94x192','fontweight','bold'); subplot(212); project1; pcolorm(xlat_grid2,xlon_grid2,skt_grid2); plotm(lat,long,'k'); caxis([mini maxi]); title('skt jan 1948 on T30 Gaussian GRID 48x96','fontweight','bold'); subplot('position',[ ]);project1; pcolorm(xlat_grid1,xlon_grid1,skt_grid1); % set N. of colors. 10

11 caxis([mini maxi]); h=colorbar('horiz'); set(h,'position',[ ]); print -djpeg90./output/skt_interp2.jpg exercise 12. DO_griddata.m % Perform interpolation between different irregular grids. clear cd C:\ENRICO\tutorials\esercizi\day_3\ex12; filenamein = '../../day_1/data/skt.mon.mean.nc'; f = netcdf(filenamein,'nowrite'); var1= f{'skt'}; skt_grid1=var1(1,:,:); % Get the first time step % of the NCEP SKT series % 94x192. lat_grid1=f{'lat'}(:); % Get the lat [94] lon_grid1=f{'lon'}(:); % and lon [192] vectors %% Interp. SKT field on ORCA2 ARAKAWA-C grid -> %% ZI = [XI,YI,ZI]=GRIDDATA(X,Y,Z,XI,YI) % see in./grids_figure/ the two grids: gaussian and arakawa-c % grid_ncep_94x192.jpg & grid_orca2_149x182.jpg [lon_grid2,lat_grid2]=gridcoord('orca2','t'); % Load lat,lon ORCA matrices lon_grid2=lon_grid2+360; % Set >0 lon values nota360=find(lon_grid2 > 360); % lon_grid2(nota360)=lon_grid2(nota360)-360; % skt_grid2 = griddata(lon_grid1',lat_grid1,... % 192,94 skt_grid1,... % 94x192 lon_grid2,lat_grid2); % 149x182,149x182 %% Plotting [xlon_grid1,xlat_grid1]=meshgrid(lon_grid1,lat_grid1); load coast; mini=round(min(skt_grid1(:))); maxi=round(max(skt_grid1(:))); cmap=colormap(jet(round(maxi-mini))); % set N. of colors. figure subplot(211); project1; pcolorm(xlat_grid1,xlon_grid1,skt_grid1); plotm(lat,long,'k'); caxis([mini maxi]); title('skt jan 1948 on NCEP Data GRID 94x192','fontweight','bold'); subplot(212); project1; pcolorm(lat_grid2,lon_grid2,skt_grid2); plotm(lat,long,'k'); caxis([mini maxi]); title('skt jan 1948 on ARAKAWA-C GRID 149x182','fontweight','bold'); subplot('position',[ ]);project1; pcolorm(xlat_grid1,xlon_grid1,skt_grid1); 11

12 caxis([mini maxi]); h=colorbar('horiz'); set(h,'position',[ ]); print -djpeg90./output/skt_griddata.jpg exercise

13 Exercise n. 13 Aim: GLOBAL EOFs slp & Saving in grd format. Data:...esercizi/day_3/data/ z500.25ond.grd Solution: DO_EOF.m % Estimating, plotting and saving in grd format EOFs of a z500 dataset clear all; %%%%%%%%%%%%%%%%%%%%%%%%%%% %% Main Settings month = [ 'OND' ]; dataset = [ 'NCEP' ]; namevar = [ 'Z500' ]; in = [ '..\Data\z500.25ond.grd' ]; type='direct'; alatg = [ -90:2.5:90 ]; along = [ 0:2.5:360 ]; resol = [144 73]; itt = 25; linear_detr = 'yes'; factor = 100.; signo = -1.; nro = [ 8 ]; mode=1; % Input dataset 25 y OND % 'direct' or 'sequential' % Info about the grid % Resolution [longitude latitude] % Time series length [years] % Perform a linear detr? % 'yes' or 'no' % Factor to plotting issues... % If you want to change the sign (flip-flop) % Number of modes to save % Mode to plot % of settings %%%%%%%%%%%%%%%%%%%%%%%%%%% % Grid 2.5x2.5 [axllon,axllat]=meshgrid(along,alatg); %%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%% %% Read data [fid,message]=fopen(in,'r','b') [var]=read_grd(fid,type,resol(1),resol(2),itt); % 10512x25 fclose(fid); %%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%% %% Weight by cos(lat) lat=axllat(:,1:resol(1)); fcos=cos(lat(:,:)*3.14/180); %fcos 13 1 fcos=fcos'; fcos=reshape(fcos,resol(1)*resol(2),1); for it=1:itt 13

14 exercise 13. var(:,it)=var(:,it).*fcos(:,1); % %% Detr? switch linear_detr case 'yes' dt=['dt']; vart=var'; vart=detr(vart,'linear'); var=vart'; case 'no' dt=['nodt']; vart=var'; vart=detr(vart,'constant'); var=vart'; %% Compute EOF [u,lam,v,proj]=eof(var,nro); tit = [ dataset ', ' namevar ', ' month ]; stat1 = [ 'EOF' ]; stat2 = [ 'PC' ]; %% flip-flop u=u*signo; proj=proj*signo; %% Plot EOFs % Title including the variance titstr=cell(size(1:nro)); modeindex=[ 1:1:nro ] for i=1:nro ii=modeindex(i); titstr{i} = [ stat1 '-' num2str(ii) ' ' num2str(lam(ii)*100,'%-2.0f') '%']; %%%% %% multiply by factor u=u*factor; % 10512x8 %% closing the grid... 73x145xnro u=reshape(u,resol(1),resol(2),nro); % 144x73x8 ub=zeros([ resol(1)+1 resol(2) nro ]); % 145x73x8 ub(1:resol(1),:,:)=u(:,:,:); % 145x73x8 ub(145,:,:)=u(1,:,:); % 145x73x8 ub=permute(ub, [ ]); % 73x145x8 max(max(ub(:,:,mode))) min(min(ub(:,:,mode))) %% plotting the EOF map_global title ( tit ); h=pcolorm(axllat,axllon,ub(:,:,mode)); caxis([-3 3]); cmap=colormap(jet(24)); % set N. of colors. cmap([12 13],:)=1; colorbar('horizon'); shading interp; % Contours % hold on; % [c1,h1]=contourm(axllat,axllon,ub(:,:,mode),[-3:0.2:-0.2],'b'); % set(h1,'linestyle','--','linewidth',1.0,'visible','on') % hold on; 14

15 % [c2,h2]=contourm(axllat,axllon,ub(:,:,mode),[0.2:0.2:3],'r'); % set(h2,'linestyle','-','linewidth',1.0,'visible','on') hold on; [c3,h3]=contourm(axllat,axllon,ub(:,:,mode),[ 0 0 ],'k'); set(h3,'linestyle','-','linewidth',1.5,'visible','on') hold on; load coast plotm(lat,long,'k') %% EOFn and variance text('position',[1.1,1.8],'string',titstr(mode)) out1 = [ './output/' stat1 num2str(mode) '_' namevar '_' month ] % Save figure print('-djpeg100',[ out1 '.jpeg']); exercise 13. %% Plotting the PC pc_plot(tit,(proj(:,mode)/factor),mode); out2 = [ './output/' stat2 num2str(mode) namevar '_' month ] % Save figure print('-djpeg100',[ out2 '.jpeg']); %% Saving PC and VARIANCE in mat format % saving the PCs file1 = [ './output/' stat2 's_' namevar '_' month '.mat' ] pc=proj; eval ([ ' save ', file1, ' pc ' ]); % saving the variance filevar = [ './output/' stat1 '_varianza_' namevar '_' month '.mat' ] varianza = lam(:)*100 eval ([ ' save ', filevar, ' varianza ' ]); %% saving the EOFs in grd format %file11 = [ './' stat1 's_' namevar '_' month '.mat' ] %eof=ub; %eval ([ ' save ', file11, ' eof ' ]); eof2save=ones(1,73,145,8);eof2save(:)=nan; eof2save(1,:,:,:)=ub; % 1x73x145x8 eof2save=permute(eof2save,[ ]); % 8x1x73x145 we use the modes as time output = [./output/ stat1 's_' namevar '_' month] % for grd writing. m2grd(eof2save,'eof',[1],alatg',along,output,'float32') 15

MATLAB & Practical Application on Climate Variability Studies EXERCISES

MATLAB & Practical Application on Climate Variability Studies EXERCISES B.Aires, 20-24/02/06 - Centro de Investigaciones del Mar y la Atmosfera Department of Atmospheric and Oceanic Sciences (UBA) DAY4 Exercise n. 14 Aim: S-EXTRATROPICAL EOFs & Saving in netcdf format. Data:..esercizi\day_3\

More information

MATLAB & Practical Application on Climate Variability Studies EXERCISES

MATLAB & Practical Application on Climate Variability Studies EXERCISES B.Aires, 20-24/02/06 - Centro de Investigaciones del Mar y la Atmosfera & Department of Atmospheric and Oceanic Sciences (UBA) DAY1 Exercise n. 1 Read an SST field in netcdf format, subsample and save

More information

MATLAB & Practical Application on Climate Variability Studies EXERCISES

MATLAB & Practical Application on Climate Variability Studies EXERCISES B.Aires, 20-24/02/06 - Centro de Investigaciones del Mar y la Atmosfera & Department of Atmospheric and Oceanic Sciences (UBA) DAY2 Exercise n. 5 Aim: Read nino3 SSTA series in binary format, plot and

More information

MATLAB & Practical Applications on Climate Variability Studies tutorial

MATLAB & Practical Applications on Climate Variability Studies tutorial MATLAB & Practical Applications on Climate Variability Studies tutorial B.Aires, 20-24/02/06 Centro de Investigaciones del Mar y la Atmosfera & Department of Atmospheric and Oceanic Sciences (UBA) E.Scoccimarro,

More information

ITACS : Interactive Tool for Analysis of the Climate System

ITACS : Interactive Tool for Analysis of the Climate System Contents 1 2 3 4 ITACS : Interactive Tool for Analysis of the Climate System Features of the ITACS Atmospheric Analysis Data, Outgoing Longwave Radiation (by NOAA), SST, Ocean Analysis Data, etc. Plain

More information

There is also a more in-depth GUI called the Curve Fitting Toolbox. To run this toolbox, type the command

There is also a more in-depth GUI called the Curve Fitting Toolbox. To run this toolbox, type the command Matlab bootcamp Class 4 Written by Kyla Drushka More on curve fitting: GUIs Thanks to Anna (I think!) for showing me this. A very simple way to fit a function to your data is to use the Basic Fitting GUI.

More information

Simulation and visualization of simple leapfrog advection scheme. ATMO 558 Term Project Koichi Sakaguchi

Simulation and visualization of simple leapfrog advection scheme. ATMO 558 Term Project Koichi Sakaguchi Simulation and visualization of simple leapfrog advection scheme ATMO 558 Term Project Koichi Sakaguchi Outline 1. Motivation 2. Method 2D a) Equations b) Model domain & grid setup c) Initial condition

More information

3 Selecting the standard map and area of interest

3 Selecting the standard map and area of interest Anomalies, EOF/PCA Mati Kahru 2005-2008 1 Anomalies, EOF/PC analysis with WAM 1 Introduction Calculating anomalies is a method of change detection in time series. Empirical Orthogonal Function (EOF) analysis

More information

Interpolation. Computer User Training Course Paul Dando. User Support. ECMWF 25 February 2016

Interpolation. Computer User Training Course Paul Dando. User Support. ECMWF 25 February 2016 Interpolation Computer User Training Course 2016 Paul Dando User Support advisory@ecmwf.int ECMWF 25 February 2016 1 Contents Introduction Overview of Interpolation Spectral Transformations Grid point

More information

Intro to Matlab for GEOL 1520: Ocean Circulation and Climate or, Notions for the Motions of the Oceans

Intro to Matlab for GEOL 1520: Ocean Circulation and Climate or, Notions for the Motions of the Oceans Intro to Matlab for GEOL 50: Ocean Circulation and Climate or, Notions for the Motions of the Oceans Baylor Fox-Kemper January 6, 07 Contacts The professor for this class is: Baylor Fox-Kemper baylor@brown.edu

More information

NCL variable based on a netcdf variable model

NCL variable based on a netcdf variable model NCL variable based on a netcdf variable model netcdf files self describing (ideally) all info contained within file no external information needed to determine file contents portable [machine independent]

More information

EcoGEnIE: A practical course in global ocean ecosystem modelling

EcoGEnIE: A practical course in global ocean ecosystem modelling EcoGEnIE: A practical course in global ocean ecosystem modelling Lesson zero.c: Ocean circulation and Atlantic overturning stability Stuff to keep in mind: Nothing at all keep your mind completely empty

More information

McIDAS-V Tutorial Displaying Gridded Data updated January 2016 (software version 1.5)

McIDAS-V Tutorial Displaying Gridded Data updated January 2016 (software version 1.5) McIDAS-V Tutorial Displaying Gridded Data updated January 2016 (software version 1.5) McIDAS-V is a free, open source, visualization and data analysis software package that is the next generation in SSEC's

More information

Start > All Programs > OpenGrADS 2.0 > Grads Prompt

Start > All Programs > OpenGrADS 2.0 > Grads Prompt 1. GrADS TUTORIAL This document presents a brief tutorial for Brian Doty's Grid Analysis and Display System (GrADS). The following sample session will give you a feeling for how to use the basic capabilities

More information

Each of the sections has an explanation followed with the option to select the parameters.

Each of the sections has an explanation followed with the option to select the parameters. A)Introduction to DTDM (the code, input control file, how to run) 1)The code for DTDM (Dynamics and Thermodynamics Demonstration Model) was developed in Fortran 77 by Rob Fovell. We have installed the

More information

Introduction to Matlab

Introduction to Matlab Introduction to Matlab Enrique Muñoz Ballester Dipartimento di Informatica via Bramante 65, 26013 Crema (CR), Italy enrique.munoz@unimi.it Contact Email: enrique.munoz@unimi.it Office: Room BT-43 Industrial,

More information

Magics support in CDO

Magics support in CDO Magics support in CDO Creating of contour, vector and graph plots January 2016 Kameswarrao Modali, Ralf Müller, Uwe Schulzweida Max Planck Institute for Meteorology Contents 1 Introduction 3 2 Building

More information

GrADS for Beginners. Laura Mariotti

GrADS for Beginners. Laura Mariotti GrADS for Beginners Laura Mariotti mariotti@ictp.it Outline n What is GrADS and how do I get it? n GrADS essentials n Getting started n Gridded data sets n Displaying data n Script language n Saving your

More information

Exercises with Level-2 satellite data

Exercises with Level-2 satellite data Exercises with Level-2 satellite data Mati Kahru WimSoft, http://www.wimsoft.com Email: wim@wimsoft.com also at Scripps Institution of Oceanography UCSD, La Jolla, CA 92093-0218, USA mkahru@ucsd.edu 10/25/2008

More information

Ocean Data View (ODV) Manual V1.0

Ocean Data View (ODV) Manual V1.0 Ocean Data View (ODV) Manual V1.0 Prepared by the Coastal and Regional Oceanography Lab UNSW, Australia (www.oceanography.unsw.edu.au ) for the Sydney Institute of Marine Science. Table of Contents 1 Introduction

More information

Chapter 11. Above: Principal contraction rates calculated from GPS velocities. Visualized using MATLAB.

Chapter 11. Above: Principal contraction rates calculated from GPS velocities. Visualized using MATLAB. Chapter 11 Above: Principal contraction rates calculated from GPS velocities. Visualized using MATLAB. We have used MATLAB to visualize data a lot in this course, but we have only scratched the surface

More information

WinADCP User s Guide. P/N (November 2001) RD Instruments Acoustic Doppler Solutions

WinADCP User s Guide. P/N (November 2001) RD Instruments Acoustic Doppler Solutions WinADCP User s Guide P/N 957-6158-00 (November 2001) RD Instruments Acoustic Doppler Solutions Table of Contents 1 Introduction... 1 1.1 System Requirements...1 1.2 Software Installation...2 2 Using WinADCP...

More information

1 An Introduction to GrADS Software

1 An Introduction to GrADS Software 1 An Introduction to GrADS Software The Grid Analysis and Display System (GrADS) is an interactive desktop tool to display earth science data. The followings are the features of GrADS. Advantages Free

More information

PyNGL & PyNIO Geoscience Visualization & Data IO Modules

PyNGL & PyNIO Geoscience Visualization & Data IO Modules PyNGL & PyNIO Geoscience Visualization & Data IO Modules SciPy 08 Dave Brown National Center for Atmospheric Research Boulder, CO Topics What are PyNGL and PyNIO? Quick summary of PyNGL graphics PyNIO

More information

IPSL Boot Camp Part 5:

IPSL Boot Camp Part 5: IPSL Boot Camp Part 5: CDO and NCO Sabine Radanovics, Jérôme Servonnat March 24, 2016 1 / 33 Group exercise Suppose... We have Tasks 30 years climate model simulation 1 file per month, 6 hourly data netcdf

More information

Python Development Technical Note 4

Python Development Technical Note 4 Python Development Technical Note 4 Peter Higgins, October 1, 2018 Introduction Programmed data analysis, and resultant presentation graphics (especially done by me) needs to be accomplished without using

More information

New Features of HYCOM. Alan J. Wallcraft Naval Research Laboratory. 10th HYCOM Consortium Meeting

New Features of HYCOM. Alan J. Wallcraft Naval Research Laboratory. 10th HYCOM Consortium Meeting New Features of HYCOM Alan J. Wallcraft Naval Research Laboratory 10th HYCOM Consortium Meeting November 7-9, 2006 Report Documentation Page Form Approved OMB No. 0704-0188 Public reporting burden for

More information

WRF-NMM Standard Initialization (SI) Matthew Pyle 8 August 2006

WRF-NMM Standard Initialization (SI) Matthew Pyle 8 August 2006 WRF-NMM Standard Initialization (SI) Matthew Pyle 8 August 2006 1 Outline Overview of the WRF-NMM Standard Initialization (SI) package. More detailed look at individual SI program components. SI software

More information

Appendix C MATLAB Scripts

Appendix C MATLAB Scripts Appix C: MATLAB Scripts Appix C MATLAB Scripts Two Matlab scripts readadcp.m and movsov.m, have been applied as part of the modelling process. Caluwaerts (2003) developed the first script in his thesis

More information

Acquiring and Processing NREL Wind Prospector Data. Steven Wallace, Old Saw Consulting, 27 Sep 2016

Acquiring and Processing NREL Wind Prospector Data. Steven Wallace, Old Saw Consulting, 27 Sep 2016 Acquiring and Processing NREL Wind Prospector Data Steven Wallace, Old Saw Consulting, 27 Sep 2016 NREL Wind Prospector Interactive web page for viewing and querying wind data Over 40,000 sites in the

More information

GLY 6932/6862 Numerical Methods in Earth Sciences Spring 2009

GLY 6932/6862 Numerical Methods in Earth Sciences Spring 2009 T-03-17-2009 GLY 6932/6862 Numerical Methods in Earth Sciences Spring 2009 Lesson 7 Geospatial Analysis (and other 3-d data) (With acknowledgements to C. Connors, W&L Univ.) In Earth sciences, we often

More information

CAM History and I/O Infrastructure Changes

CAM History and I/O Infrastructure Changes CAM History and I/O Infrastructure Changes Steve Goldhaber National Center for Atmospheric Research CGD: Atmospheric Modeling & Predictability June 16, 2015 What is the problem? Outline Introdution to

More information

McIDAS-V Tutorial Displaying Gridded Data updated June 2015 (software version 1.5)

McIDAS-V Tutorial Displaying Gridded Data updated June 2015 (software version 1.5) McIDAS-V Tutorial Displaying Gridded Data updated June 2015 (software version 1.5) McIDAS-V is a free, open source, visualization and data analysis software package that is the next generation in SSEC's

More information

Analysis Methods in Atmospheric and Oceanic Science

Analysis Methods in Atmospheric and Oceanic Science Analysis Methods in Atmospheric and Oceanic Science 1 AOSC 652 Introduction to Graphics and Analysis of Satellite Measurements of Atmospheric Composition: Day 2 14 Sep 2016 AOSC 652: Analysis Methods in

More information

Lab: Scientific Computing Tsunami-Simulation

Lab: Scientific Computing Tsunami-Simulation Lab: Scientific Computing Tsunami-Simulation Session 3: netcdf, Tsunamis Sebastian Rettenberger, Michael Bader 10.11.15 Session 3: netcdf, Tsunamis, 10.11.15 1 netcdf (Network Common Data Form) Interface

More information

SeaSonde Combine Site Application Guide for SeaDisplay

SeaSonde Combine Site Application Guide for SeaDisplay SeaSonde Combine Site Application Guide for SeaDisplay CODAR OCEAN SENSORS, LTD. 1000 Fremont Ave., Suite 145, Los Altos, CA 94024-6057 USA Tel. (408) 773-8240 FAX (408) 773-0514 www.codaros.com e-mail:

More information

In this exercise, you ll create a netcdf raster layer using the variable tmin. You will change the display by selecting a different time step.

In this exercise, you ll create a netcdf raster layer using the variable tmin. You will change the display by selecting a different time step. Learning to Work with Temporal Data in ArcGIS Working with a netcdf File in ArcGIS Objective NetCDF (network Common Data Form) is a file format for storing multidimensional scientific data (variables)

More information

Introduction to Computer Vision

Introduction to Computer Vision Introduction to Computer Vision Michael J. Black Oct 2009 Motion estimation Goals Motion estimation Affine flow Optimization Large motions Why affine? Monday dense, smooth motion and regularization. Robust

More information

Lab 6: Graphical Methods

Lab 6: Graphical Methods Lab 6: Graphical Methods 6.1 Introduction EGR 53L - Fall 2009 Lab this week is going to introduce graphical solution and presentation techniques as well as surface plots. 6.2 Resources The additional resources

More information

Useful Matlab Plotting of Topogrpahy and Ancillary Data

Useful Matlab Plotting of Topogrpahy and Ancillary Data Adaptive Signal Processing Laboratory (ASPL) Electrical and Computer Engineering Department University of Florida Useful Matlab Plotting of Topogrpahy and Ancillary Data ASPL Report No. Rep_2004-12-001

More information

An introduction to the GOCE error variance covariance products: A user s perspective. Rory Bingham Newcastle University

An introduction to the GOCE error variance covariance products: A user s perspective. Rory Bingham Newcastle University An introduction to the GOCE error variance covariance products: A user s perspective Rory Bingham Newcastle University rory.bingham@ncl.ac.uk The ESA GOCE Virtual Archive The variance-covariance matrices

More information

% README.m % Information for files illustrating Sound & Vibration article: % Brandt & Ahlin, Sampling and Time-Domain Analysis, May 2010.

% README.m % Information for files illustrating Sound & Vibration article: % Brandt & Ahlin, Sampling and Time-Domain Analysis, May 2010. README.m Information for files illustrating Sound & Vibration article: Brandt & Ahlin, Sampling and Time-Domain Analysis, May 2010. Installation: Unpack the files into a directory and go inside MATLAB

More information

Ocean Simulations using MPAS-Ocean

Ocean Simulations using MPAS-Ocean Ocean Simulations using MPAS-Ocean Mark Petersen and the MPAS-Ocean development team Los Alamos National Laboratory U N C L A S S I F I E D Slide 1 Progress on MPAS-Ocean in 2010 MPAS-Ocean is a functioning

More information

Exercises with Level-2 satellite data

Exercises with Level-2 satellite data Exercises with Level-2 satellite data Mati Kahru WimSoft, http://www.wimsoft.com Email: wim@wimsoft.com & Scripps Institution of Oceanography UCSD, La Jolla, CA 92093-0218, USA mkahru@ucsd.edu 24-Jan-15

More information

Delft3d-FLOW Quick Start Manual

Delft3d-FLOW Quick Start Manual Delft3d-FLOW Quick Start Manual Michael Kliphuis April 2, 2018 1. Introduction Delft3D-FLOW is a multi-dimensional (2D or 3D) hydrodynamic (and transport) simulation program which calculates non-steady

More information

matlab_intro.html Page 1 of 5 Date: Tuesday, September 6, 2005

matlab_intro.html Page 1 of 5 Date: Tuesday, September 6, 2005 matlab_intro.html Page 1 of 5 % Introducing Matlab % adapted from Eero Simoncelli (http://www.cns.nyu.edu/~eero) % and Hany Farid (http://www.cs.dartmouth.edu/~farid) % and Serge Belongie (http://www-cse.ucsd.edu/~sjb)

More information

SES 123 Global and Regional Energy Lab Procedures

SES 123 Global and Regional Energy Lab Procedures SES 123 Global and Regional Energy Lab Procedures Introduction An important aspect to understand about our planet is global temperatures, including spatial variations, such as between oceans and continents

More information

Data Processing. Dennis Shea National Center for Atmospheric Research. NCAR is sponsored by the National Science Foundation

Data Processing. Dennis Shea National Center for Atmospheric Research. NCAR is sponsored by the National Science Foundation Data Processing Dennis Shea National Center for Atmospheric Research NCAR is sponsored by the National Science Foundation Data Processing: Meta Data Know Your Data: most important rule in data processing

More information

Examples, examples: Outline

Examples, examples: Outline Examples, examples: Outline Overview of todays exercises Basic scripting Importing data Working with temporal data Working with missing data Interpolation in 1D Some time series analysis Linear regression

More information

Gridded data from many sources

Gridded data from many sources Gridded data from many sources A data-user's perspective Heiko Klein 26.09.2014 Background MET used legacy format (felt) for gridded data since ~1980s -Index 2d fields -«unique» parameter table 2012 decided

More information

SES 123 Global and Regional Energy Lab Worksheet

SES 123 Global and Regional Energy Lab Worksheet SES 123 Global and Regional Energy Lab Worksheet Introduction An important aspect to understand about our planet is global temperatures, including spatial variations, such as between oceans and continents

More information

AN APPLICATION OF THE RADON TRANSFORM TO STUDY PLANETARY WAVES IN THE INDIAN OCEAN

AN APPLICATION OF THE RADON TRANSFORM TO STUDY PLANETARY WAVES IN THE INDIAN OCEAN AN APPLICATION OF THE RADON TRANSFORM TO STUDY PLANETARY WAVES IN THE INDIAN OCEAN Sara de la Rosa (1), Paolo Cipollini (2), Helen M. Snaith (2) (1) (2) ZMAW-IfM, Universität Hamburg - Bundesstr. 53/55

More information

Mini-Project System Simulation over AWGN Using BPSK Modulation

Mini-Project System Simulation over AWGN Using BPSK Modulation Mini-Project System Simulation over AWGN Using BPSK Modulation Part I: MATLAB Environment Due Date: June 5, 2006. This exercise will guide you to realize the basic operating environment. Some useful instructions

More information

About the SPEEDY model (from Miyoshi PhD Thesis):

About the SPEEDY model (from Miyoshi PhD Thesis): SPEEDY EXPERIMENTS. About the SPEEDY model (from Miyoshi PhD Thesis): The SPEEDY model (Molteni 2003) is a recently developed atmospheric general circulation model (AGCM) with a spectral primitive-equation

More information

Introduction to R. UCLA Statistical Consulting Center R Bootcamp. Irina Kukuyeva September 20, 2010

Introduction to R. UCLA Statistical Consulting Center R Bootcamp. Irina Kukuyeva September 20, 2010 UCLA Statistical Consulting Center R Bootcamp Irina Kukuyeva ikukuyeva@stat.ucla.edu September 20, 2010 Outline 1 Introduction 2 Preliminaries 3 Working with Vectors and Matrices 4 Data Sets in R 5 Overview

More information

Matlab for FMRI Module 1: the basics Instructor: Luis Hernandez-Garcia

Matlab for FMRI Module 1: the basics Instructor: Luis Hernandez-Garcia Matlab for FMRI Module 1: the basics Instructor: Luis Hernandez-Garcia The goal for this tutorial is to make sure that you understand a few key concepts related to programming, and that you know the basics

More information

C =

C = file:///c:/documents20and20settings/ravindra/desktop/html/exercis... 1 of 5 10/3/2008 3:17 PM Lab Exercise 2 - Matrices Hyd 510L, Fall, 2008, NM Tech Programmed by J.L. Wilson, Sept, 2008 Problem 2.1 Create

More information

Day 3: Diagnostics and Output

Day 3: Diagnostics and Output Day 3: Diagnostics and Output Adam Phillips Climate Variability Working Group Liaison CGD/NCAR Thanks to Dennis Shea, Andrew Gettelman, and Christine Shields for their assistance Outline Day 3: Diagnostics

More information

SST Retrieval Methods in the ESA Climate Change Initiative

SST Retrieval Methods in the ESA Climate Change Initiative ESA Climate Change Initiative Phase-II Sea Surface Temperature (SST) www.esa-sst-cci.org SST Retrieval Methods in the ESA Climate Change Initiative Owen Embury Climate Change Initiative ESA Climate Change

More information

Coastal Ocean Modeling & Dynamics

Coastal Ocean Modeling & Dynamics DISTRIBUTION STATEMENT A. Approved for public release; distribution is unlimited. Coastal Ocean Modeling & Dynamics Roger M. Samelson College of Oceanic and Atmospheric Sciences Oregon State University

More information

Ecography. Supplementary material

Ecography. Supplementary material Ecography ECOG-03031 Fordham, D. A., Saltré, F., Haythorne, S., Wigley, T. M. L., Otto-Bliesner, B. L., Chan, K. C. and Brooks, B. W. 2017. PaleoView: a tool for generating continuous climate projections

More information

New Features of HYCOM. Alan J. Wallcraft Naval Research Laboratory. 14th Layered Ocean Model Workshop

New Features of HYCOM. Alan J. Wallcraft Naval Research Laboratory. 14th Layered Ocean Model Workshop New Features of HYCOM Alan J. Wallcraft Naval Research Laboratory 14th Layered Ocean Model Workshop August 22, 2007 HYCOM 2.2 (I) Maintain all features of HYCOM 2.1 Orthogonal curvilinear grids Can emulate

More information

CCNY. BME 2200: BME Biostatistics and Research Methods. Lecture 4: Graphing data with MATLAB

CCNY. BME 2200: BME Biostatistics and Research Methods. Lecture 4: Graphing data with MATLAB BME 2200: BME Biostatistics and Research Methods Lecture 4: Graphing data with MATLAB Lucas C. Parra Biomedical Engineering Department CCNY parra@ccny.cuny.edu 1 Content, Schedule 1. Scientific literature:

More information

SGLI Level-2 data Mati Kahru

SGLI Level-2 data Mati Kahru SGLI Level-2 data Mati Kahru 2018 1 Working with SGLI Level-2 data Contents Working with SGLI Level-2 data... 1 1 Introduction... 1 2 Evaluating SGLI Level-2 data... 1 3 Finding match-ups in SGLI Level-2

More information

Getting started with MATLAB

Getting started with MATLAB Sapienza University of Rome Department of economics and law Advanced Monetary Theory and Policy EPOS 2013/14 Getting started with MATLAB Giovanni Di Bartolomeo giovanni.dibartolomeo@uniroma1.it Outline

More information

Improving Oceanographic Anomaly Detection Using High Performance Computing

Improving Oceanographic Anomaly Detection Using High Performance Computing Improving Oceanographic Anomaly Detection Using High Performance Computing Thomas Huang, Ed Armstrong, George Chang, Toshio Chin, Brian Wilson, Tong (Tony) Lee, Victor Zlotnicki. Jorge Vazquez and Michelle

More information

Dynamics of the Atmosphere GEMPAK Supplementary Handout

Dynamics of the Atmosphere GEMPAK Supplementary Handout Dynamics of the Atmosphere GEMPAK Supplementary Handout Vertical coordinates PRES Pressure TROP Tropopause level FRZL Freezing level CLDT Cloud-top level CLDL Cloud-base level HGHT Height above the ground

More information

Lecture 22 - Chapter 8 (Raster Analysis, part 3)

Lecture 22 - Chapter 8 (Raster Analysis, part 3) GEOL 452/552 - GIS for Geoscientists I Lecture 22 - Chapter 8 (Raster Analysis, part 3) Today: Zonal Analysis (statistics) for polygons, lines, points, interpolation (IDW), Effects Toolbar, analysis masks

More information

Syed RH Rizvi.

Syed RH Rizvi. Community Tools: gen_be Syed RH Rizvi National Center For Atmospheric Research NCAR/ESSL/MMM, Boulder, CO-80307, USA rizvi@ucar.edu 0 Talk overview What is gen_be? How it works? Some technical details

More information

Current. 1 Library Import. 2 Data Import. February 17, Station Data

Current. 1 Library Import. 2 Data Import. February 17, Station Data Current February 17, 2016 1 Library Import In [1]: import pandas as pd import matplotlib.pyplot as plt import numpy as np from mpl_toolkits.basemap import Basemap from midget.dataviews.adam import obs

More information

NCL Regridding using ESMF

NCL Regridding using ESMF NCL Regridding using ESMF Version: 2018/10/18 Contact: Karin Meier-Fleischer Deutsches Klimarechenzentrum (DKRZ) Bundesstrasse 45a D-20146 Hamburg Germany Email: meier-fleischer@dkrz.de http://www.dkrz.de/

More information

INTERNATIONAL EDITION. MATLAB for Engineers. Third Edition. Holly Moore

INTERNATIONAL EDITION. MATLAB for Engineers. Third Edition. Holly Moore INTERNATIONAL EDITION MATLAB for Engineers Third Edition Holly Moore 5.4 Three-Dimensional Plotting Figure 5.8 Simple mesh created with a single two-dimensional matrix. 5 5 Element,5 5 The code mesh(z)

More information

Tim Love. July 24, Introduction 2. 2 Info and help commands 2

Tim Love. July 24, Introduction 2. 2 Info and help commands 2 Using Matlab at CUED Tim Love July 24, 2006 Abstract This document does not try to describe matlab comprehensively (see matlab s HelpDesk or the installed tutorial documents 1 for this), rather it introduces

More information

Multiple Regression White paper

Multiple Regression White paper +44 (0) 333 666 7366 Multiple Regression White paper A tool to determine the impact in analysing the effectiveness of advertising spend. Multiple Regression In order to establish if the advertising mechanisms

More information

New Features of HYCOM. Alan J. Wallcraft Naval Research Laboratory. 15th Layered Ocean Model Workshop

New Features of HYCOM. Alan J. Wallcraft Naval Research Laboratory. 15th Layered Ocean Model Workshop New Features of HYCOM Alan J. Wallcraft Naval Research Laboratory 15th Layered Ocean Model Workshop February 9, 2011 HYCOM 2.2 (I) Maintain all features of HYCOM 2.1 Orthogonal curvilinear grids Can emulate

More information

Outline. Case Study. Colormaps. Announcements. Syllabus Case Study Task 1: Animation. Each frame in animation contains. field. map.

Outline. Case Study. Colormaps. Announcements. Syllabus Case Study Task 1: Animation. Each frame in animation contains. field. map. Outline Announcements HW II due today HW III available shortly Remember, send me ideas by Wed. Syllabus Case Study Task 1: Animation Case Study Each frame in animation contains + map field Colormaps Clim(1)

More information

SeeG3 Users Manual V2.00 Micro-g Solutions Inc. Erie, Colorado, USA

SeeG3 Users Manual V2.00 Micro-g Solutions Inc. Erie, Colorado, USA SeeG3 Users Manual V2.00 Micro-g Solutions Inc. Erie, Colorado, USA September, 2003 Table of Contents Table of Contents 0 Table of Contents 1 Introduction 2 System Requirements 2 Installing SeeG3 3 SeeG3

More information

IDL Tutorial. Contours and Surfaces. Copyright 2008 ITT Visual Information Solutions All Rights Reserved

IDL Tutorial. Contours and Surfaces. Copyright 2008 ITT Visual Information Solutions All Rights Reserved IDL Tutorial Contours and Surfaces Copyright 2008 ITT Visual Information Solutions All Rights Reserved http://www.ittvis.com/ IDL is a registered trademark of ITT Visual Information Solutions for the computer

More information

University of Rochester - FTP Site Statistics. Top 20 Directories Sorted by Disk Space

University of Rochester - FTP Site Statistics. Top 20 Directories Sorted by Disk Space Property Value FTP Server ftp.cs.rochester.edu Description University of Rochester Country United States Scan Date 02/Sep/2015 Total Dirs 204 Total Files 2,949 Total Data 20.85 GB Top 20 Directories Sorted

More information

Getting Started (a short tutorial):

Getting Started (a short tutorial): GridBuilder Introduction: GridBuilder is intended for rapid development of grids for numerical ocean models with a particular emphasis on elements commonly used in ROMS. The GridBuilder program combines

More information

Vector: A series of scalars contained in a column or row. Dimensions: How many rows and columns a vector or matrix has.

Vector: A series of scalars contained in a column or row. Dimensions: How many rows and columns a vector or matrix has. ASSIGNMENT 0 Introduction to Linear Algebra (Basics of vectors and matrices) Due 3:30 PM, Tuesday, October 10 th. Assignments should be submitted via e-mail to: matlabfun.ucsd@gmail.com You can also submit

More information

PRISM A Software Infrastructure Project for Climate Research in Europe

PRISM A Software Infrastructure Project for Climate Research in Europe PRISM A Software Infrastructure Project for Climate Research in Europe OASIS4 User Guide (OASIS4_0_2) Edited by: S. Valcke, CERFACS R. Redler, NEC-CCRLE PRISM Support Initiative Technical Report No 4 August

More information

First TUFMAN Training Workshop (TTW-1) 3-7 December 2012 SPC, Noumea, New Caledonia. Session 9.0

First TUFMAN Training Workshop (TTW-1) 3-7 December 2012 SPC, Noumea, New Caledonia. Session 9.0 First TUFMAN Training Workshop (TTW-1) 3-7 December 2012 SPC, Noumea, New Caledonia Session 9.0 Mapping with TUFMAN 1 INTRODUCTION... 2 2 PRE-REQUISITES... 2 3 HOW TO ACCESS THE MAPPING MODULE... 3 4 MAIN

More information

OBAN Class Homework Assignment No. 4 Distributed on November 3, Due Thursday, December 1, 2016

OBAN Class Homework Assignment No. 4 Distributed on November 3, Due Thursday, December 1, 2016 OBAN Class Homework Assignment No. 4 Distributed on November 3, 2016 Due Thursday, December 1, 2016 Original document on ANALAB was written by Huang, Gustafsson and Robertson (2000), and can be found in

More information

Aquarius Scatterometer Stability

Aquarius Scatterometer Stability Aquarius Scatterometer Stability Greg Neumann, Simon Yueh, Alex Fore, Adam Freedman, Akiko Hayashi, Wenqing Tang 30 Oct 2012 Ancillary Data Correlations With Scatterometer Sigma0 Correlation calculated

More information

(5) ifit/math: «One Class to do some Math» God damn it! Just compute it! ifit workshop NBI Jan 2012 Math - 1

(5) ifit/math: «One Class to do some Math» God damn it! Just compute it! ifit workshop NBI Jan 2012 Math - 1 (5) ifit/math: «One Class to do some Math» God damn it! Just compute it! ifit workshop NBI Jan 2012 Math - 1 Math: perform mathematical operations seamlessly As we have seen there is a unique,

More information

PC-MATLAB PRIMER. This is intended as a guided tour through PCMATLAB. Type as you go and watch what happens.

PC-MATLAB PRIMER. This is intended as a guided tour through PCMATLAB. Type as you go and watch what happens. PC-MATLAB PRIMER This is intended as a guided tour through PCMATLAB. Type as you go and watch what happens. >> 2*3 ans = 6 PCMATLAB uses several lines for the answer, but I ve edited this to save space.

More information

5.1 Further data input

5.1 Further data input 88 geo111 numerical skills in geoscience 5.1 Further data input Previously, you imported ASCII data into MATLAB using the load command 1. You might not have realized it at the time, but the use of load

More information

MATLAB 7. The Language of Technical Computing KEY FEATURES

MATLAB 7. The Language of Technical Computing KEY FEATURES MATLAB 7 The Language of Technical Computing MATLAB is a high-level technical computing language and interactive environment for algorithm development, data visualization, data analysis, and numerical

More information

Mobile Century data documentation

Mobile Century data documentation Mobile Century data documentation December 16, 2009 Contents 1 USER AGREEMENT, TERMS OF USE 1 2 DESCRIPTION OF THE DATA 2 2.1 Inductive loop detector data................... 2 2.1.1 Inductive loop detector

More information

HYSPLIT model description and operational set up for benchmark case study

HYSPLIT model description and operational set up for benchmark case study HYSPLIT model description and operational set up for benchmark case study Barbara Stunder and Roland Draxler NOAA Air Resources Laboratory Silver Spring, MD, USA Workshop on Ash Dispersal Forecast and

More information

SeaSonde Radial Site Release 6 SeaDisplay Ver6 Application Guide Apr 23, 2009 Copyright CODAR Ocean Sensors, Ltd

SeaSonde Radial Site Release 6 SeaDisplay Ver6 Application Guide Apr 23, 2009 Copyright CODAR Ocean Sensors, Ltd CODAR O C E A N S E N S O R S SeaSonde Radial Site Release 6 SeaDisplay Ver6 Application Guide Apr 23, 2009 Copyright CODAR Ocean Sensors, Ltd SeaDisplay plots SeaSonde radial, elliptical, and total vectors

More information

RegCM-ROMS Tutorial: Coupling RegCM-ROMS

RegCM-ROMS Tutorial: Coupling RegCM-ROMS RegCM-ROMS Tutorial: Coupling RegCM-ROMS Ufuk Utku Turuncoglu ICTP (International Center for Theoretical Physics) Earth System Physics Section - Outline Outline Information about coupling and ESMF Installation

More information

The sspline Package. October 11, 2007

The sspline Package. October 11, 2007 The sspline Package October 11, 2007 Version 0.1-5 Date 2007/10/10 Title Smoothing Splines on the Sphere Author Xianhong Xie Maintainer Xianhong Xie Depends R (>=

More information

Interpolation. Introduction and basic concepts. Computer User Training Course Paul Dando. User Support Section.

Interpolation. Introduction and basic concepts. Computer User Training Course Paul Dando. User Support Section. Interpolation Introduction and basic concepts Computer User Training Course 2011 Paul Dando User Support Section advisory@ecmwf.int 1 Contents Introduction Overview Spectral Transformations Grid point

More information

Metview Macro Language

Metview Macro Language Metview Macro Language Iain Russell, Sándor Kertész, Fernando Ii Development Section, ECMWF Macro Introduction Designed to perform data manipulation and plotting from within the Metview environment Slide

More information

Introduction to the Kinematics Tool

Introduction to the Kinematics Tool Introduction to the Kinematics Tool Author: Samantha Ross EarthByte Group, University of Sydney Introduction to the Kinematics Tool Aim Included Files Background Exercise 1 - Using the Kinematics Tool

More information

Sentinel-1 Toolbox. Offset Tracking Tutorial Issued August Jun Lu Luis Veci

Sentinel-1 Toolbox. Offset Tracking Tutorial Issued August Jun Lu Luis Veci Sentinel-1 Toolbox Offset Tracking Tutorial Issued August 2016 Jun Lu Luis Veci Copyright 2016 Array Systems Computing Inc. http://www.array.ca/ http://step.esa.int Offset Tracking Tutorial The goal of

More information

Toolbox Verification and Validation Report

Toolbox Verification and Validation Report WP2500 Deliverable: Toolbox Verification and Validation Report Version: 2; 19 August 2011 GUT 2 VERSION 2 OF THE GOCE USER TOOLBOX Ref: ESA/XGCE- DTEX- EOPS- SW- 09-0001 GUTS Phase 3: GUT Development and

More information

GP265 /EE 355 Homework 8 (Final project 2)

GP265 /EE 355 Homework 8 (Final project 2) GP265 /EE 355 Homework 8 (Final project 2) March 14, 2018 1. Display interferogram phase 2. Calculate the curved earth fringe pattern and subtract it from the interferogram phase. First I compute the slant

More information