SF.net SVN: matplotlib: [5196] trunk/toolkits/basemap/examples
Revision: 5196
http://matplotlib.svn.sourceforge.net/matplotlib/?rev=5196&view=rev
Author: jswhit
Date: 2008-05-20 04:52:12 -0700 (Tue, 20 May 2008)
Log Message:
---
convert more examples to numpy/pyplot namespace
Modified Paths:
--
trunk/toolkits/basemap/examples/README
trunk/toolkits/basemap/examples/customticks.py
trunk/toolkits/basemap/examples/fcstmaps.py
trunk/toolkits/basemap/examples/geos_demo.py
trunk/toolkits/basemap/examples/geos_demo_2.py
trunk/toolkits/basemap/examples/geos_demo_3.py
trunk/toolkits/basemap/examples/hires.py
trunk/toolkits/basemap/examples/nytolondon.py
trunk/toolkits/basemap/examples/ortho_demo.py
trunk/toolkits/basemap/examples/plotcities.py
trunk/toolkits/basemap/examples/quiver_demo.py
trunk/toolkits/basemap/examples/randompoints.py
Modified: trunk/toolkits/basemap/examples/README
===
--- trunk/toolkits/basemap/examples/README 2008-05-19 19:09:35 UTC (rev
5195)
+++ trunk/toolkits/basemap/examples/README 2008-05-20 11:52:12 UTC (rev
5196)
@@ -52,6 +52,9 @@
from a jpeg file, then plot only a portion of the full earth (contributed
by Scott Sinclair, requires PIL).
+geos_demo_3.py shows how to make a regional geostationary or orthographic
+plot, where part of the region is outside the projection limb.
+
fcstmaps.py is a sample multi-panel plot that accesses
data over http using the dap module. An internet connection is required.
Modified: trunk/toolkits/basemap/examples/customticks.py
===
--- trunk/toolkits/basemap/examples/customticks.py 2008-05-19 19:09:35 UTC
(rev 5195)
+++ trunk/toolkits/basemap/examples/customticks.py 2008-05-20 11:52:12 UTC
(rev 5196)
@@ -1,37 +1,38 @@
from mpl_toolkits.basemap import Basemap
-import pylab, numpy
+import numpy as np
+import matplotlib.pyplot as plt
from matplotlib.ticker import FuncFormatter
# example showing how to create custom tick labels for a cylindrical
# projection.
def lat2str(deg):
-min = 60 * (deg - numpy.floor(deg))
-deg = numpy.floor(deg)
+min = 60 * (deg - np.floor(deg))
+deg = np.floor(deg)
dir = 'N'
if deg < 0:
if min != 0.0:
deg += 1.0
min -= 60.0
dir = 'S'
-return (u"%d\N{DEGREE SIGN} %g' %s") % (numpy.abs(deg),numpy.abs(min),dir)
+return (u"%d\N{DEGREE SIGN} %g' %s") % (np.abs(deg),np.abs(min),dir)
def lon2str(deg):
-min = 60 * (deg - numpy.floor(deg))
-deg = numpy.floor(deg)
+min = 60 * (deg - np.floor(deg))
+deg = np.floor(deg)
dir = 'E'
if deg < 0:
if min != 0.0:
deg += 1.0
min -= 60.0
dir = 'W'
-return (u"%d\N{DEGREE SIGN} %g' %s") % (numpy.abs(deg),numpy.abs(min),dir)
+return (u"%d\N{DEGREE SIGN} %g' %s") % (np.abs(deg),np.abs(min),dir)
# (1) use matplotlib custom tick formatter
# instead of Basemap labelling methods.
# create figure.
-fig=pylab.figure()
+fig=plt.figure()
# create Basemap instance (regular lat/lon projection).
# suppress_ticks=False allows custom axes ticks to be used
# Ticks are suppressed by default, so Basemap methods
@@ -44,7 +45,7 @@
# background color will be used for oceans.
m.drawmapboundary(fill_color='aqua')
# get axes instance.
-ax = pylab.gca()
+ax = plt.gca()
# add custom ticks.
# This only works for projection='cyl'.
def xformat(x, pos=None): return lon2str(x)
@@ -62,7 +63,7 @@
# custom formatting function with the 'fmt' keyword.
# create figure.
-fig = pylab.figure()
+fig = plt.figure()
# create Basemap instance.
m = Basemap(llcrnrlon=-156.5,llcrnrlat=18.75,urcrnrlon=-154.5,urcrnrlat=20.5,
resolution='h',projection='cyl')
@@ -73,8 +74,8 @@
m.drawmapboundary(fill_color='aqua')
# label meridians and parallels, passing string formatting function
# with 'fmt' keyword.
-m.drawparallels(numpy.linspace(18,21,7),labels=[1,0,0,0],fmt=lat2str,dashes=[2,2])
-m.drawmeridians(numpy.linspace(-157,-154,7),labels=[0,0,0,1],fmt=lon2str,dashes=[2,2])
-pylab.title('Hawaii')
+m.drawparallels(np.linspace(18,21,7),labels=[1,0,0,0],fmt=lat2str,dashes=[2,2])
+m.drawmeridians(np.linspace(-157,-154,7),labels=[0,0,0,1],fmt=lon2str,dashes=[2,2])
+plt.title('Hawaii')
-pylab.show()
+plt.show()
Modified: trunk/toolkits/basemap/examples/fcstmaps.py
===
--- trunk/toolkits/basemap/examples/fcstmaps.py 2008-05-19 19:09:35 UTC (rev
5195)
+++ trunk/toolkits/basemap/examples/fcstmaps.py 2008-05-20 11:52:12 UTC (rev
5196)
@@ -1,8 +1,7 @@
# this example reads today's numerical weather forecasts
# from the NOAA OpenDAP servers and makes a multi-panel plot.
-from pylab import title, show, figure, cm, figtext, \
- meshgrid, axes, colorbar
-import numpy
+import numpy as np
+import matp
SF.net SVN: matplotlib: [5197] trunk/toolkits/basemap/examples
Revision: 5197
http://matplotlib.svn.sourceforge.net/matplotlib/?rev=5197&view=rev
Author: jswhit
Date: 2008-05-20 05:22:09 -0700 (Tue, 20 May 2008)
Log Message:
---
more examples updated to numpy/pyplot namespace
Modified Paths:
--
trunk/toolkits/basemap/examples/ccsm_popgrid.py
trunk/toolkits/basemap/examples/fillstates.py
trunk/toolkits/basemap/examples/garp.py
trunk/toolkits/basemap/examples/hurrtracks.py
trunk/toolkits/basemap/examples/panelplot.py
trunk/toolkits/basemap/examples/plot_tissot.py
trunk/toolkits/basemap/examples/plotprecip.py
trunk/toolkits/basemap/examples/plotsst.py
trunk/toolkits/basemap/examples/pnganim.py
trunk/toolkits/basemap/examples/polarmaps.py
trunk/toolkits/basemap/examples/setwh.py
trunk/toolkits/basemap/examples/show_colormaps.py
trunk/toolkits/basemap/examples/testgdal.py
Modified: trunk/toolkits/basemap/examples/ccsm_popgrid.py
===
--- trunk/toolkits/basemap/examples/ccsm_popgrid.py 2008-05-20 11:52:12 UTC
(rev 5196)
+++ trunk/toolkits/basemap/examples/ccsm_popgrid.py 2008-05-20 12:22:09 UTC
(rev 5197)
@@ -20,10 +20,10 @@
POP grids are used extensively locally in oceanographic and ice models.
"""
-import pylab as pl
from matplotlib import rcParams
-from numpy import ma as MA
-import numpy as N
+from numpy import ma
+import numpy as np
+import matplotlib.pyplot as plt
from mpl_toolkits.basemap import Basemap, NetCDFFile
# read in data from netCDF file.
@@ -36,17 +36,17 @@
fpin.close()
# make longitudes monotonically increasing.
-tlon = N.where(N.greater_equal(tlon,min(tlon[:,0])),tlon-360,tlon)
+tlon = np.where(np.greater_equal(tlon,min(tlon[:,0])),tlon-360,tlon)
# stack grids side-by-side (in longitiudinal direction), so
# any range of longitudes may be plotted on a world map.
-tlon = N.concatenate((tlon,tlon+360),1)
-tlat = N.concatenate((tlat,tlat),1)
-temp = MA.concatenate((temp,temp),1)
+tlon = np.concatenate((tlon,tlon+360),1)
+tlat = np.concatenate((tlat,tlat),1)
+temp = ma.concatenate((temp,temp),1)
tlon = tlon-360.
-pl.figure(figsize=(6,8))
-pl.subplot(2,1,1)
+plt.figure(figsize=(6,8))
+plt.subplot(2,1,1)
# subplot 1 just shows POP grid cells.
map = Basemap(projection='merc', lat_ts=20, llcrnrlon=-180, \
urcrnrlon=180, llcrnrlat=-84, urcrnrlat=84, resolution='c')
@@ -55,22 +55,22 @@
map.fillcontinents(color='white')
x, y = map(tlon,tlat)
-im = map.pcolor(x,y,MA.masked_array(N.zeros(temp.shape,'f'), temp.mask),\
-shading='faceted',cmap=pl.cm.cool,vmin=0,vmax=0)
+im = map.pcolor(x,y,ma.masked_array(np.zeros(temp.shape,'f'), temp.mask),\
+shading='faceted',cmap=plt.cm.cool,vmin=0,vmax=0)
# disclaimer: these are not really the grid cells because of the
# way pcolor interprets the x and y args.
-pl.title('(A) CCSM POP Grid Cells')
+plt.title('(A) CCSM POP Grid Cells')
# subplot 2 is a contour plot of surface temperature from the
# CCSM ocean model.
-pl.subplot(2,1,2)
+plt.subplot(2,1,2)
map.drawcoastlines()
map.fillcontinents(color='white')
CS1 = map.contourf(x,y,temp,15)
CS2 = map.contour(x,y,temp,15,colors='black',linewidths=0.5)
-pl.title('(B) Surface Temp contours on POP Grid')
+plt.title('(B) Surface Temp contours on POP Grid')
-pl.show()
-#pl.savefig('ccsm_popgrid.ps')
+plt.show()
+#plt.savefig('ccsm_popgrid.ps')
Modified: trunk/toolkits/basemap/examples/fillstates.py
===
--- trunk/toolkits/basemap/examples/fillstates.py 2008-05-20 11:52:12 UTC
(rev 5196)
+++ trunk/toolkits/basemap/examples/fillstates.py 2008-05-20 12:22:09 UTC
(rev 5197)
@@ -1,5 +1,5 @@
-import pylab as p
-import numpy
+import numpy as np
+import matplotlib.pyplot as plt
from mpl_toolkits.basemap import Basemap as Basemap
from matplotlib.colors import rgb2hex
from matplotlib.patches import Polygon
@@ -68,7 +68,7 @@
# choose a color for each state based on population density.
colors={}
statenames=[]
-cmap = p.cm.hot # use 'hot' colormap
+cmap = plt.cm.hot # use 'hot' colormap
vmin = 0; vmax = 450 # set range.
print m.states_info[0].keys()
for shapedict in m.states_info:
@@ -79,10 +79,10 @@
# calling colormap with value between 0 and 1 returns
# rgba value. Invert color range (hot colors are high
# population), take sqrt root to spread out colors more.
-colors[statename] = cmap(1.-p.sqrt((pop-vmin)/(vmax-vmin)))[:3]
+colors[statename] = cmap(1.-np.sqrt((pop-vmin)/(vmax-vmin)))[:3]
statenames.append(statename)
# cycle through state names, color each one.
-ax = p.gca() # get current axes instance
+ax = plt.gca() # get current axes instance
for nshape,seg in enumerate(m.states):
# skip DC and Puerto Rico.
if statenames[nshape] not in ['District of Columbia','Puerto Rico']:
@@ -90,7 +90,7 @@
poly = Poly
SF.net SVN: matplotlib: [5198] trunk/toolkits/basemap/examples/ simpletest_oo.py
Revision: 5198
http://matplotlib.svn.sourceforge.net/matplotlib/?rev=5198&view=rev
Author: jswhit
Date: 2008-05-20 05:24:54 -0700 (Tue, 20 May 2008)
Log Message:
---
more examples converted to numpy/pyplot namespace.
Modified Paths:
--
trunk/toolkits/basemap/examples/simpletest_oo.py
Modified: trunk/toolkits/basemap/examples/simpletest_oo.py
===
--- trunk/toolkits/basemap/examples/simpletest_oo.py2008-05-20 12:22:09 UTC
(rev 5197)
+++ trunk/toolkits/basemap/examples/simpletest_oo.py2008-05-20 12:24:54 UTC
(rev 5198)
@@ -7,15 +7,16 @@
from matplotlib.backends.backend_agg import FigureCanvasAgg as FigureCanvas
from mpl_toolkits.basemap import Basemap
from matplotlib.figure import Figure
-import numpy
+import numpy as np
+import matplotlib.mlab as mlab
import matplotlib.cm as cm
from matplotlib.mlab import load
# read in topo data (on a regular lat/lon grid)
# longitudes go from 20 to 380.
-etopo = load('etopo20data.gz')
-lons = load('etopo20lons.gz')
-lats = load('etopo20lats.gz')
+etopo = mlab.load('etopo20data.gz')
+lons = mlab.load('etopo20lons.gz')
+lats = mlab.load('etopo20lats.gz')
# create figure.
fig = Figure()
canvas = FigureCanvas(fig)
@@ -25,15 +26,15 @@
# set 'ax' keyword so pylab won't be imported.
m = Basemap(projection='robin',lon_0=0.5*(lons[0]+lons[-1]),ax=ax)
# make filled contour plot.
-x, y = m(*numpy.meshgrid(lons, lats))
+x, y = m(*np.meshgrid(lons, lats))
cs = m.contourf(x,y,etopo,30,cmap=cm.jet)
# draw coastlines.
m.drawcoastlines()
# draw a line around the map region.
m.drawmapboundary()
# draw parallels and meridians.
-m.drawparallels(numpy.arange(-60.,90.,30.),labels=[1,0,0,0],fontsize=10)
-m.drawmeridians(numpy.arange(0.,420.,60.),labels=[0,0,0,1],fontsize=10)
+m.drawparallels(np.arange(-60.,90.,30.),labels=[1,0,0,0],fontsize=10)
+m.drawmeridians(np.arange(0.,420.,60.),labels=[0,0,0,1],fontsize=10)
# add a title.
ax.set_title('Robinson Projection')
# add a colorbar.
This was sent by the SourceForge.net collaborative development platform, the
world's largest Open Source development site.
-
This SF.net email is sponsored by: Microsoft
Defy all challenges. Microsoft(R) Visual Studio 2008.
http://clk.atdmt.com/MRT/go/vse012070mrt/direct/01/
___
Matplotlib-checkins mailing list
[email protected]
https://lists.sourceforge.net/lists/listinfo/matplotlib-checkins
SF.net SVN: matplotlib: [5199] trunk/toolkits/basemap/lib/mpl_toolkits/ basemap/basemap.py
Revision: 5199 http://matplotlib.svn.sourceforge.net/matplotlib/?rev=5199&view=rev Author: jswhit Date: 2008-05-20 08:01:46 -0700 (Tue, 20 May 2008) Log Message: --- convert to np/plt (from numpy, pylab) Modified Paths: -- trunk/toolkits/basemap/lib/mpl_toolkits/basemap/basemap.py Modified: trunk/toolkits/basemap/lib/mpl_toolkits/basemap/basemap.py === --- trunk/toolkits/basemap/lib/mpl_toolkits/basemap/basemap.py 2008-05-20 12:24:54 UTC (rev 5198) +++ trunk/toolkits/basemap/lib/mpl_toolkits/basemap/basemap.py 2008-05-20 15:01:46 UTC (rev 5199) @@ -33,8 +33,8 @@ from matplotlib.transforms import Bbox import pyproj, sys, os, math, dbflib from proj import Proj -import numpy as npy -from numpy import linspace, squeeze, ma +import numpy as np +from numpy import ma from shapelib import ShapeFile import _geoslib, pupynere, netcdftime @@ -504,7 +504,7 @@ self.llcrnrlon = llcrnrlon; self.llcrnrlat = llcrnrlat self.urcrnrlon = urcrnrlon; self.urcrnrlat = urcrnrlat # FIXME: won't work for points exactly on equator?? -if npy.abs(lat_0) < 1.e-2: lat_0 = 1.e-2 +if np.abs(lat_0) < 1.e-2: lat_0 = 1.e-2 projparams['lat_0'] = lat_0 elif projection == 'geos': if lon_0 is None: @@ -652,7 +652,7 @@ self.latmin = lats.min() self.latmax = lats.max() -# if ax == None, pylab.gca may be used. +# if ax == None, pyplot.gca may be used. self.ax = ax self.lsmask = None @@ -685,13 +685,13 @@ for seg in self.coastsegs: x, y = zip(*seg) self.coastpolygons.append((x,y)) -x = npy.array(x,npy.float64); y = npy.array(y,npy.float64) +x = np.array(x,np.float64); y = np.array(y,np.float64) xd = (x[1:]-x[0:-1])**2 yd = (y[1:]-y[0:-1])**2 -dist = npy.sqrt(xd+yd) +dist = np.sqrt(xd+yd) split = dist > 500. -if npy.sum(split) and self.projection not in ['merc','cyl','mill']: -ind = (npy.compress(split,squeeze(split*npy.indices(xd.shape)))+1).tolist() +if np.sum(split) and self.projection not in ['merc','cyl','mill']: +ind = (np.compress(split,np.squeeze(split*np.indices(xd.shape)))+1).tolist() iprev = 0 ind.append(len(xd)) for i in ind: @@ -779,9 +779,9 @@ re = self.projparams['R'] # center of stereographic projection restricted to be # nearest one of 6 points on the sphere (every 90 deg lat/lon). -lon0 = 90.*(npy.around(lon_0/90.)) -lat0 = 90.*(npy.around(lat_0/90.)) -if npy.abs(int(lat0)) == 90: lon0=0. +lon0 = 90.*(np.around(lon_0/90.)) +lat0 = 90.*(np.around(lat_0/90.)) +if np.abs(int(lat0)) == 90: lon0=0. maptran = pyproj.Proj(proj='stere',lon_0=lon0,lat_0=lat0,R=re) # boundary polygon for orthographic projection # in stereographic coorindates. @@ -806,7 +806,7 @@ # numpy array (first column is lons, second is lats). polystring = bdatfile.read(bytecount) # binary data is little endian. -b = npy.array(npy.fromstring(polystring,dtype=' 90.: +if np.abs(lon-lonprev) > 90.: if lonprev < 0: lon = lon - 360. else: @@ -1050,7 +1050,7 @@ lons[n] = lon lonprev = lon n = n + 1 -b = npy.empty((len(lons),2),npy.float64) +b = np.empty((len(lons),2),np.float64) b[:,0]=lons; b[:,1]=lats boundaryll = _geoslib.Polygon(b) return boundaryll, boundaryxy @@ -1075,10 +1075,10 @@ # get current axes instance (if none specified). if ax is None and self.ax is None: try: -ax = pylab.gca() +ax = plt.gca() except: -import pylab -ax = pylab.gca() +import matplotlib.pyplot as plt +ax = plt.gca() elif ax is None and self.ax is not None: ax = self.ax limb = None @@ -1104,19 +1104,19 @@ # quasi-elliptical region. lon_0 = self.projparams['lon_0'] # left side -lats1 = linspace(-89.9,89.9,ny).tolist() +lats1 = np.linspace(-89.9,89.9,ny).tolist() lons1 = len(lats1)*[lon_0-179.9] # top. -lons2 = linspace(lon_0-179.9,lon_0+179.9,nx).tolist() +lons2 = np.linspace(lon_0-179.9,lon_0+179.9,nx).tolist() la
SF.net SVN: matplotlib: [5200] trunk/toolkits/basemap/lib/mpl_toolkits/ basemap/basemap.py
Revision: 5200 http://matplotlib.svn.sourceforge.net/matplotlib/?rev=5200&view=rev Author: jswhit Date: 2008-05-20 08:08:21 -0700 (Tue, 20 May 2008) Log Message: --- fix problems caused by change to "import numpy as np" Modified Paths: -- trunk/toolkits/basemap/lib/mpl_toolkits/basemap/basemap.py Modified: trunk/toolkits/basemap/lib/mpl_toolkits/basemap/basemap.py === --- trunk/toolkits/basemap/lib/mpl_toolkits/basemap/basemap.py 2008-05-20 15:01:46 UTC (rev 5199) +++ trunk/toolkits/basemap/lib/mpl_toolkits/basemap/basemap.py 2008-05-20 15:08:21 UTC (rev 5200) @@ -1003,7 +1003,7 @@ yy = np.linspace(self.ymin, self.ymax, ny)[:-1] x = len(yy)*[self.xmin]; y = yy.tolist() # top (y = ymax, xmin <= x <= xmax) -xx = np.np.linspace(self.xmin, self.xmax, nx)[:-1] +xx = np.linspace(self.xmin, self.xmax, nx)[:-1] x = x + xx.tolist() y = y + len(xx)*[self.ymax] # right side (x = xmax, ymin <= y <= ymax) @@ -1193,7 +1193,7 @@ ax = self.ax # get axis background color. axisbgc = ax.get_axis_bgcolor() -np = 0 +npt = 0 for x,y in self.coastpolygons: xa = np.array(x,np.float32) ya = np.array(y,np.float32) @@ -1213,7 +1213,7 @@ hasp3 = np.sum(test1*test4) if not hasp1 or not hasp2 or not hasp3 or not hasp4: xy = zip(xa.tolist(),ya.tolist()) -if self.coastpolygontypes[np] not in [2,4]: +if self.coastpolygontypes[npt] not in [2,4]: poly = Polygon(xy,facecolor=color,edgecolor=color,linewidth=0) else: # lakes filled with background color by default if lake_color is None: @@ -1223,7 +1223,7 @@ if zorder is not None: poly.set_zorder(zorder) ax.add_patch(poly) -np = np + 1 +npt = npt + 1 # set axes limits to fit map region. self.set_axes_limits(ax=ax) return poly This was sent by the SourceForge.net collaborative development platform, the world's largest Open Source development site. - This SF.net email is sponsored by: Microsoft Defy all challenges. Microsoft(R) Visual Studio 2008. http://clk.atdmt.com/MRT/go/vse012070mrt/direct/01/ ___ Matplotlib-checkins mailing list [email protected] https://lists.sourceforge.net/lists/listinfo/matplotlib-checkins
SF.net SVN: matplotlib: [5201] trunk/toolkits/basemap/lib/mpl_toolkits/ basemap/basemap.py
Revision: 5201 http://matplotlib.svn.sourceforge.net/matplotlib/?rev=5201&view=rev Author: jswhit Date: 2008-05-20 08:14:39 -0700 (Tue, 20 May 2008) Log Message: --- change variable name Modified Paths: -- trunk/toolkits/basemap/lib/mpl_toolkits/basemap/basemap.py Modified: trunk/toolkits/basemap/lib/mpl_toolkits/basemap/basemap.py === --- trunk/toolkits/basemap/lib/mpl_toolkits/basemap/basemap.py 2008-05-20 15:08:21 UTC (rev 5200) +++ trunk/toolkits/basemap/lib/mpl_toolkits/basemap/basemap.py 2008-05-20 15:14:39 UTC (rev 5201) @@ -1193,7 +1193,7 @@ ax = self.ax # get axis background color. axisbgc = ax.get_axis_bgcolor() -npt = 0 +npoly = 0 for x,y in self.coastpolygons: xa = np.array(x,np.float32) ya = np.array(y,np.float32) @@ -1213,7 +1213,7 @@ hasp3 = np.sum(test1*test4) if not hasp1 or not hasp2 or not hasp3 or not hasp4: xy = zip(xa.tolist(),ya.tolist()) -if self.coastpolygontypes[npt] not in [2,4]: +if self.coastpolygontypes[npoly] not in [2,4]: poly = Polygon(xy,facecolor=color,edgecolor=color,linewidth=0) else: # lakes filled with background color by default if lake_color is None: @@ -1223,7 +1223,7 @@ if zorder is not None: poly.set_zorder(zorder) ax.add_patch(poly) -npt = npt + 1 +npoly = npoly + 1 # set axes limits to fit map region. self.set_axes_limits(ax=ax) return poly This was sent by the SourceForge.net collaborative development platform, the world's largest Open Source development site. - This SF.net email is sponsored by: Microsoft Defy all challenges. Microsoft(R) Visual Studio 2008. http://clk.atdmt.com/MRT/go/vse012070mrt/direct/01/ ___ Matplotlib-checkins mailing list [email protected] https://lists.sourceforge.net/lists/listinfo/matplotlib-checkins
SF.net SVN: matplotlib: [5205] branches/v0_91_maint
Revision: 5205 http://matplotlib.svn.sourceforge.net/matplotlib/?rev=5205&view=rev Author: jdh2358 Date: 2008-05-20 14:02:08 -0700 (Tue, 20 May 2008) Log Message: --- remove pesky date auto xlabel Modified Paths: -- branches/v0_91_maint/CODING_GUIDE branches/v0_91_maint/lib/matplotlib/dates.py Modified: branches/v0_91_maint/CODING_GUIDE === --- branches/v0_91_maint/CODING_GUIDE 2008-05-20 16:00:21 UTC (rev 5204) +++ branches/v0_91_maint/CODING_GUIDE 2008-05-20 21:02:08 UTC (rev 5205) @@ -46,7 +46,8 @@ keep them in sync. http://www.orcaware.com/svn/wiki/Svnmerge.py. The basic procedure is: - - install svnmerge.py in your PATH + - install svnmerge.py in your PATH: + wget http://svn.collab.net/repos/svn/trunk/contrib/client-side/svnmerge/svnmerge.py - get a svn copy of the branch (svn co https://matplotlib.svn.sourceforge.net/svnroot/matplotlib/branches/v0_91_maint) Modified: branches/v0_91_maint/lib/matplotlib/dates.py === --- branches/v0_91_maint/lib/matplotlib/dates.py2008-05-20 16:00:21 UTC (rev 5204) +++ branches/v0_91_maint/lib/matplotlib/dates.py2008-05-20 21:02:08 UTC (rev 5205) @@ -1003,7 +1003,7 @@ return units.AxisInfo( majloc = majloc, majfmt = majfmt, -label='date', +label='', ) else: return None axisinfo = staticmethod(axisinfo) This was sent by the SourceForge.net collaborative development platform, the world's largest Open Source development site. - This SF.net email is sponsored by: Microsoft Defy all challenges. Microsoft(R) Visual Studio 2008. http://clk.atdmt.com/MRT/go/vse012070mrt/direct/01/ ___ Matplotlib-checkins mailing list [email protected] https://lists.sourceforge.net/lists/listinfo/matplotlib-checkins
SF.net SVN: matplotlib: [5206] trunk/matplotlib
Revision: 5206 http://matplotlib.svn.sourceforge.net/matplotlib/?rev=5206&view=rev Author: jdh2358 Date: 2008-05-20 14:05:49 -0700 (Tue, 20 May 2008) Log Message: --- Merged revisions 5205 via svnmerge from https://matplotlib.svn.sourceforge.net/svnroot/matplotlib/branches/v0_91_maint r5205 | jdh2358 | 2008-05-20 16:02:08 -0500 (Tue, 20 May 2008) | 1 line remove pesky date auto xlabel Modified Paths: -- trunk/matplotlib/CODING_GUIDE trunk/matplotlib/lib/matplotlib/dates.py Property Changed: trunk/matplotlib/ Property changes on: trunk/matplotlib ___ Name: svnmerge-integrated - /branches/v0_91_maint:1-5193 + /branches/v0_91_maint:1-5205 Modified: trunk/matplotlib/CODING_GUIDE === --- trunk/matplotlib/CODING_GUIDE 2008-05-20 21:02:08 UTC (rev 5205) +++ trunk/matplotlib/CODING_GUIDE 2008-05-20 21:05:49 UTC (rev 5206) @@ -46,7 +46,8 @@ keep them in sync. http://www.orcaware.com/svn/wiki/Svnmerge.py. The basic procedure is: - - install svnmerge.py in your PATH + - install svnmerge.py in your PATH: + wget http://svn.collab.net/repos/svn/trunk/contrib/client-side/svnmerge/svnmerge.py - get a svn copy of the branch (svn co https://matplotlib.svn.sourceforge.net/svnroot/matplotlib/branches/v0_91_maint) Modified: trunk/matplotlib/lib/matplotlib/dates.py === --- trunk/matplotlib/lib/matplotlib/dates.py2008-05-20 21:02:08 UTC (rev 5205) +++ trunk/matplotlib/lib/matplotlib/dates.py2008-05-20 21:05:49 UTC (rev 5206) @@ -997,7 +997,7 @@ return units.AxisInfo( majloc = majloc, majfmt = majfmt, -label='date', +label='', ) else: return None axisinfo = staticmethod(axisinfo) This was sent by the SourceForge.net collaborative development platform, the world's largest Open Source development site. - This SF.net email is sponsored by: Microsoft Defy all challenges. Microsoft(R) Visual Studio 2008. http://clk.atdmt.com/MRT/go/vse012070mrt/direct/01/ ___ Matplotlib-checkins mailing list [email protected] https://lists.sourceforge.net/lists/listinfo/matplotlib-checkins
