From basriaz at gmail.com Tue Mar 19 07:18:47 2019 From: basriaz at gmail.com (Basmah Riaz) Date: Tue, 19 Mar 2019 12:18:47 +0100 Subject: [AstroPy] Fits to data table Message-ID: Hi, I'm new to python and am trying to learn the basics of handling fits images. Is it possible to extract a data table from a fits image cube? I'm trying to write a data table of pixel (column 1) and integrated flux (column 2) from the fits image. I had followed the steps given here: http://docs.astropy.org/en/stable/io/fits/index.html In [1]: from astropy.io import fits In [2]: hdul=fits.open('moment0.fits') In [3]: hdul.info() Filename: moment0.fits No. Name Ver Type Cards Dimensions Format 0 PRIMARY 1 PrimaryHDU 82 (98, 100, 1) float32 In [4]: data = hdul[0].data In [5]: data Out[5]: array([[[ nan, nan, nan, ..., nan, nan, nan], [ nan, nan, nan, ..., nan, nan, nan], [ nan, nan, nan, ..., nan, nan, nan], ..., [ nan, nan, nan, ..., nan, nan, nan], [ nan, nan, nan, ..., nan, nan, nan], [ nan, nan, nan, ..., nan, nan, nan]]], dtype=float32) In [6]: data[0:2,1:2] Out[6]: array([[[ nan, nan, nan, nan, nan, nan, nan, nan, nan, 1.04565542e+24, 8.37304559e+23, 9.44501255e+23, 1.00440115e+24, 1.17914651e+24, 1.23599454e+24, 1.30693366e+24, 1.25854511e+24, 1.46356597e+24, 1.27364925e+24, 1.37587937e+24, 1.43363339e+24, 1.29562667e+24, 1.33309057e+24, 1.28908398e+24, 1.34466921e+24, 1.31942643e+24, 1.41336892e+24, 1.36305788e+24, 1.33955442e+24, 1.34887939e+24, 1.32828144e+24, 1.45468487e+24, 1.47349839e+24, 1.40765259e+24, 1.39326082e+24, 1.42740358e+24, 1.41948114e+24, 1.43646987e+24, 1.44934440e+24, 1.44043736e+24, 1.46360921e+24, 1.46183486e+24, 1.54993752e+24, 1.43122306e+24, 1.51683685e+24, 1.41424529e+24, 1.45172604e+24, 1.47353255e+24, 1.47837381e+24, 1.41663414e+24, 1.38960880e+24, 1.43003786e+24, 1.57839825e+24, 1.40306195e+24, 1.46425600e+24, 1.36871310e+24, 1.46037324e+24, 1.46366829e+24, 1.43932046e+24, 1.35849389e+24, 1.49760929e+24, 1.38901879e+24, 1.39916551e+24, 1.48571042e+24, 1.47773552e+24, 1.44545631e+24, 1.47139647e+24, 1.43888524e+24, 1.43438077e+24, 1.50250258e+24, 1.36998895e+24, nan, nan, nan, nan, nan, nan, nan, nan, nan, nan, nan, nan, nan, nan, nan, nan, nan, nan, nan, nan, nan, nan, nan, nan, nan, nan, nan]]], dtype=float32) I can see the flux values at a range in pixel values, but how do I write it as a simple two-column ascii file? Cheers, Basmah -------------- next part -------------- An HTML attachment was scrubbed... URL: From ejsaiet at alaska.edu Sat Mar 16 20:57:23 2019 From: ejsaiet at alaska.edu (Eyal Saiet) Date: Sat, 16 Mar 2019 16:57:23 -0800 Subject: [AstroPy] fft_psd_tools and radialAverageBins() in astropy 3.1 Message-ID: Hello, As can be seen below, astropy 2.7 has the class fft_psd_tools and the radialAverageBins() function. Looking at astropy 3.1, I cannot find the class and respected function, fft_psd_tools and adialAverageBins(). Was it deprecated in astropy 3.0? thanks [image: image.png] * The radially averaged power spectrum(RAPS) is s the direction-independent mean spectrum, i.e. the average of all possible directional power spectra. The radially averaged power spectrum provides a convenient means to view and compare information contained in 2-D spectra in 1-D. This function computes and plots the RAPS of an input matrix (does not consider corner values outside averaging radius). The image can be rectangular but must be 2-D (e.g., multi-color channel data is not supported). The spatial resolution of the data is also specified (https://www.mathworks.com/matlabcentral/fileexchange/23636-radially-averaged-power-spectrum-of-2d-real-valued-matrix ) Thanks -- Eyal -------------- next part -------------- An HTML attachment was scrubbed... URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: image.png Type: image/png Size: 127927 bytes Desc: not available URL: From ejensen1 at swarthmore.edu Wed Mar 20 13:35:04 2019 From: ejensen1 at swarthmore.edu (Eric L. N. Jensen) Date: Wed, 20 Mar 2019 13:35:04 -0400 Subject: [AstroPy] Fwd: A question about reading fits table. In-Reply-To: References: Message-ID: Hello, That error is saying that one of your columns (in this case it must be UVW2) says in the column header that it contains floating-point (numerical) data, but that one of the entries in that column doesn?t contain a number, but instead contains the string ? ---? and the code doesn?t know how to convert that string into a number. It might be the case that whatever software wrote that FITS table used that string to denote missing values in the table. You should look at the FITS-reading routine you?re using and see if there is a way to tell it how to handle missing values in the data. Hope this helps, Eric > On Jan 20, 2019, at 7:55 AM, ?? wrote: > > Dear members, > > I'm a PhD student on Diffuse Interstellar Bands (DIBs). > I experienced a problem when I tried to get data from a fits table. > > The read in code: > `hdu1 = fits.open()` > `data = hdu1[1].data` > A warning occurred, > "WARNING: VerifyWarning: It is strongly recommended that column names contain only upper and lower-case ASCII letters, digits, or underscores for maximum compatibility with other software (got '---'). [astropy.io.fits.column]" > > The columns of the data is like: > > > When I accessed the data with `data[0]`, I met an error: > > > This also occurred when I got the column `data['UVW2'], but I successfully accessed to the columns like 'Name' and 'RAdeg' in the data. > > I don't what causes this error and can't solve it. > If you have some comments, please contact me. > > Best regards, > He Zhao > _______________________________________________ > AstroPy mailing list > AstroPy at python.org > https://mail.python.org/mailman/listinfo/astropy -------------- next part -------------- A non-text attachment was scrubbed... Name: smime.p7s Type: application/pkcs7-signature Size: 3932 bytes Desc: not available URL: From sic at elte.hu Wed Mar 20 16:13:35 2019 From: sic at elte.hu (Brigitta Sipocz) Date: Wed, 20 Mar 2019 13:13:35 -0700 Subject: [AstroPy] fft_psd_tools and radialAverageBins() in astropy 3.1 In-Reply-To: References: Message-ID: Hi Eyal, The documentation page you have attached is not astropy's but another package's called image_tools. It is possible that it isn't compatible with astropy version 3.1, but nevertheless it's worth trying to install both. Cheers, Brigitta On Wed, 20 Mar 2019 at 04:03, Eyal Saiet wrote: > Hello, > As can be seen below, astropy 2.7 has the class fft_psd_tools and the > radialAverageBins() function. Looking at astropy 3.1, I cannot find the > class and respected function, fft_psd_tools and adialAverageBins(). Was it > deprecated in astropy 3.0? > thanks > > > > * The radially averaged power spectrum(RAPS) is s the > direction-independent mean spectrum, i.e. the average of all possible > directional power spectra. The radially averaged power spectrum provides a > convenient means to view and compare information contained in 2-D spectra > in 1-D. This function computes and plots the RAPS of an input matrix (does > not consider corner values outside averaging radius). The image can be > rectangular but must be 2-D (e.g., multi-color channel data is not > supported). The spatial resolution of the data is also specified (https://www.mathworks.com/matlabcentral/fileexchange/23636-radially-averaged-power-spectrum-of-2d-real-valued-matrix > ) > > Thanks > -- > > Eyal > > _______________________________________________ > AstroPy mailing list > AstroPy at python.org > https://mail.python.org/mailman/listinfo/astropy > -------------- next part -------------- An HTML attachment was scrubbed... URL: From simon at sconseil.fr Wed Mar 20 17:34:22 2019 From: simon at sconseil.fr (Simon Conseil) Date: Wed, 20 Mar 2019 22:34:22 +0100 Subject: [AstroPy] Fwd: A question about reading fits table. In-Reply-To: References: Message-ID: <20190320213422.GB2570@fireball> Hi, It seems that your file has columns with missing values, but does not contain the TNULL keywords that are needed to represent the missing values. If you can share the file or at least the header, it would help to get a better idea. Best, Simon On 20/01 13:55, ?? wrote: > Dear members, > > I'm a PhD student on Diffuse Interstellar Bands (DIBs). > I experienced a problem when I tried to get data from a fits table. > > The read in code: > `hdu1 = fits.open()` > `data = hdu1[1].data` > A warning occurred, > "WARNING: VerifyWarning: It is strongly recommended that column names > contain only upper and lower-case ASCII letters, digits, or underscores for > maximum compatibility with other software (got '---'). > [astropy.io.fits.column]" > > The columns of the data is like: > [image: err1.PNG] > > When I accessed the data with `data[0]`, I met an error: > [image: Capture.PNG] > [image: Capture.PNG] > This also occurred when I got the column `data['UVW2'], but I successfully > accessed to the columns like 'Name' and 'RAdeg' in the data. > > I don't what causes this error and can't solve it. > If you have some comments, please contact me. > > Best regards, > He Zhao > _______________________________________________ > AstroPy mailing list > AstroPy at python.org > https://mail.python.org/mailman/listinfo/astropy From thomas.robitaille at gmail.com Sat Mar 23 11:01:07 2019 From: thomas.robitaille at gmail.com (Thomas Robitaille) Date: Sat, 23 Mar 2019 15:01:07 +0000 Subject: [AstroPy] Aplpy FITSFigure does not open any window In-Reply-To: References: Message-ID: Hi Vittorio, Apologies for the delay - I think that these issues should be resolved with the latest version of APLpy (2.0.3) but if not, please open an issue here: https://github.com/aplpy/aplpy/issues Thanks! Tom On Tue, 31 Oct 2017 at 18:29, Vittorio_Roma2 wrote: > Dear all > > I am having a problem with aplpy. > > I am using Python 3.5.2 under ubuntu 16.04 and installed aplpy version > 1.1.1 > > through pip3 install aplpy > > > The first problem arises when importing aplpy: > > > import/home/vittorio/.local/lib/python3.5/site-packages/matplotlib/cbook/deprecation.py:106: > > MatplotlibDeprecationWarning: The mpl_toolkits.axes_grid module was > deprecated in version 2.1. Use mpl_toolkits.axes_grid1 and > mpl_toolkits.axisartist provies the same functionality instead. > warnings.warn(message, mplDeprecation, stacklevel=1) > > I have tried to substitute mpl_toolkits.axes_grid1 with > mpl_toolkits.axes_grid in core.py > > but then I got an error (and not a warning) saying that axes_grid1 does > not have some method. > > This will just return a failure and stop everything. > > > Anyways, when I do > > >>> fitsfile='somefile.fits' > >>> F=aplpy.FITSFigure(fitsfile) > WARNING: Cannot determine equinox. Assuming J2000. [aplpy.wcs_util] > WARNING: Cannot determine equinox. Assuming J2000. [aplpy.wcs_util] > >>> F.show_grayscale() > INFO: Auto-setting vmin to 3.416e+03 [aplpy.core] > INFO: Auto-setting vmax to 2.212e+04 [aplpy.core] > > > No window at all is opening. I have also tried giving as input of > FITSFIgure > astropy.io.fits.open objects but again, no graphical window shows up. > > I have found some workaround, that is, after the above instructions, to > give > > >>>hdu_list=fits.open(fitsfile) > >>>image_data=hdu_list[0].data > >>>plt.imshow(image_data,'gray',clim=[4500,9000]) > >>>plt.show(block=False) > > This does open an astrometrized image, with the labels of the X and Y axis > in the right place. However, this does not allow me to use any of the > FITSFigure methods. Neither I can add subplots to put annotations. Finally, > to add markers, I am forced to do another workaround: to > give pixel coordinates like this > > >>>plt.scatter(pixcoords[:,0],pixcoords[:,1]) > > where pixcoords comes from WCS transformations. > > I have also tried a workaround, giving,e.g. > > >>>F.add_label(0.5,0.5,'ssss',relative=True) > > and do the plt.imshow and plt.show later, but this still does not work. > > To sum up, while it is true that I can live with the workarounds for some > very basic figures, all of this is slowing down the script and I can't call > any of the FITSFigure methods > > Any help would really be appreciated > > Best regards, Vittorio > _______________________________________________ > AstroPy mailing list > AstroPy at python.org > https://mail.python.org/mailman/listinfo/astropy > -------------- next part -------------- An HTML attachment was scrubbed... URL: From adam.g.ginsburg at gmail.com Wed Mar 20 11:43:55 2019 From: adam.g.ginsburg at gmail.com (Adam Ginsburg) Date: Wed, 20 Mar 2019 09:43:55 -0600 Subject: [AstroPy] fft_psd_tools and radialAverageBins() in astropy 3.1 In-Reply-To: References: Message-ID: The code you're pointing to is in the `image_tools` package, which is my package. It's not part of astropy and it's not an official affiliate. It uses the astropy-template, which is why the documentation looks similar, but these tools have never been part of the astropy core package. For a somewhat more up-to-date version of the azimuthally averaged power-spectrum, you should look at turbustat: https://turbustat.readthedocs.io/en/latest/api/turbustat.statistics.PowerSpectrum.html On Wed, Mar 20, 2019 at 5:03 AM Eyal Saiet wrote: > Hello, > As can be seen below, astropy 2.7 has the class fft_psd_tools and the > radialAverageBins() function. Looking at astropy 3.1, I cannot find the > class and respected function, fft_psd_tools and adialAverageBins(). Was it > deprecated in astropy 3.0? > thanks > > [image: image.png] > > * The radially averaged power spectrum(RAPS) is s the > direction-independent mean spectrum, i.e. the average of all possible > directional power spectra. The radially averaged power spectrum provides a > convenient means to view and compare information contained in 2-D spectra > in 1-D. This function computes and plots the RAPS of an input matrix (does > not consider corner values outside averaging radius). The image can be > rectangular but must be 2-D (e.g., multi-color channel data is not > supported). The spatial resolution of the data is also specified (https://www.mathworks.com/matlabcentral/fileexchange/23636-radially-averaged-power-spectrum-of-2d-real-valued-matrix > ) > > Thanks > -- > > Eyal > > _______________________________________________ > AstroPy mailing list > AstroPy at python.org > https://mail.python.org/mailman/listinfo/astropy > -- Adam Ginsburg Jansky fellow, National Radio Astronomy Observatory http://www.adamgginsburg.com/ -------------- next part -------------- An HTML attachment was scrubbed... URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: image.png Type: image/png Size: 127927 bytes Desc: not available URL: From sic at elte.hu Wed Mar 20 16:06:57 2019 From: sic at elte.hu (Brigitta Sipocz) Date: Wed, 20 Mar 2019 13:06:57 -0700 Subject: [AstroPy] fft_psd_tools and radialAverageBins() in astropy 3.1 In-Reply-To: References: Message-ID: Hi Eyal, The documentation page you have attached is not astropy's but another package's called image_tools. It is possible that it isn't compatible with astropy version 3.1, but nevertheless it's worth trying to install both. Cheers, Brigitta On Wed, 20 Mar 2019 at 04:03, Eyal Saiet wrote: > Hello, > As can be seen below, astropy 2.7 has the class fft_psd_tools and the > radialAverageBins() function. Looking at astropy 3.1, I cannot find the > class and respected function, fft_psd_tools and adialAverageBins(). Was it > deprecated in astropy 3.0? > thanks > > [image: image.png] > > * The radially averaged power spectrum(RAPS) is s the > direction-independent mean spectrum, i.e. the average of all possible > directional power spectra. The radially averaged power spectrum provides a > convenient means to view and compare information contained in 2-D spectra > in 1-D. This function computes and plots the RAPS of an input matrix (does > not consider corner values outside averaging radius). The image can be > rectangular but must be 2-D (e.g., multi-color channel data is not > supported). The spatial resolution of the data is also specified (https://www.mathworks.com/matlabcentral/fileexchange/23636-radially-averaged-power-spectrum-of-2d-real-valued-matrix > ) > > Thanks > -- > > Eyal > > _______________________________________________ > AstroPy mailing list > AstroPy at python.org > https://mail.python.org/mailman/listinfo/astropy > -------------- next part -------------- An HTML attachment was scrubbed... URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: image.png Type: image/png Size: 127927 bytes Desc: not available URL: From smartin2016 at my.fit.edu Thu Mar 28 15:34:22 2019 From: smartin2016 at my.fit.edu (Samantha Martin) Date: Thu, 28 Mar 2019 15:34:22 -0400 Subject: [AstroPy] Requesting Help for Matching Source Catalogs Using astropy.coordinates Message-ID: Hello all! I am working on a project for my undergraduate research where I am using astropy.coordinates and match_coordinates_sky to find source matches between three sets of data in RA and DEC. I am able to find the source matches between two data sets at a time. I have two questions about this. First of all, when I match my first data set to my second data set, they have 2240 matches, but when I match my first data set to my third data set, they have 3400 matches. My first data set is the one I want to match to specifically because it has the least amount of sources. *How do I ensure that all three data sets all match each other (ie. contain the same sources), not just one of the other data sets? My second question is, now that I have the source matches, how do I apply this to the rest of the parameters (magnitude, flux etc.) in my data?* After matching, I am able to output the matching RA and DEC values for each data set, but I don?t know how to apply the matches to the other 21 columns of data that correspond to these sources. In order for me to continue the project I must be able to use all of the data, not just RA and DEC. Below is the code that I have used to find my matches. I?ve been trying to search online for answers to these questions for days with no luck.* I am not sure if this a good place to ask this, and if it isn?t then could someone direct me to a good forum for these types of questions?* import numpy as np my_csv1 = np.loadtxt(open("F435W.csv"), delimiter=",") my_csv2 = np.loadtxt(open("F550M.csv"), delimiter=",") from astropy.coordinates import SkyCoord from astropy import units as u from astropy.coordinates import match_coordinates_sky c = SkyCoord(my_csv1[:, 12], my_csv1[:, 13], frame='icrs', unit='deg') catalog = SkyCoord(my_csv2[:, 12], my_csv2[:, 13], frame='icrs', unit='deg') max_sep = 1.0*u.arcsec idx, sep2d, _ = c.match_to_catalog_sky(catalog) sep_constraint = sep2d < max_sep c_matches = c[sep_constraint] catalog_matches = catalog[idx[sep_constraint]] print (len(c_matches), len(catalog_matches)) Thank you, Samantha -------------- next part -------------- An HTML attachment was scrubbed... URL: From ejensen1 at swarthmore.edu Thu Mar 28 21:31:01 2019 From: ejensen1 at swarthmore.edu (Eric Jensen) Date: Thu, 28 Mar 2019 21:31:01 -0400 Subject: [AstroPy] Requesting Help for Matching Source Catalogs Using astropy.coordinates In-Reply-To: References: Message-ID: Hi Samantha, You are 90% of the way there, and just need to do a few more things with the variables you already have. Regarding your first question, to get the three-way match, just match the first two catalogs as you?re already doing, then take either of the matched sets of coords (your variables c_matches or catalog_matches), and match *those* to the coords from your third catalog. That way you are starting with only the set of things that match across 1 and 2, and then matching that set to 3. To be on the safe side, you may want to match both c_matches and catalog_matches to your third catalog and compare the number of matches. It probably won?t be exactly the same, since the matching RA and Dec values aren?t exactly the same for a given object, so you could have some matches in catalog 3 that are right on the edge, e.g. close enough to the coords from catalog 1 but not to the coords from catalog 2. You?ll have to decide how to handle those edge cases. For your second question, you can use the same kind of indexing you?re using to get the subsets of matching coordinates, but apply it to the whole catalog. Right now you are doing this: c_matches = c[sep_constraint] so you can also use that sep_constraint variable (really a boolean mask) to index the entire catalog and get the matching subset, e.g. catalog1_matches = my_csv1[sep_constraint, :] and similarly, catalog2_matches = my_csv2[idx[sep_constraint], :] Good luck, Eric Eric Jensen Professor of Astronomy Swarthmore College > On Mar 28, 2019, at 3:34 PM, Samantha Martin > wrote: > > Hello all! > > I am working on a project for my undergraduate research where I am using astropy.coordinates and match_coordinates_sky to find source matches between three sets of data in RA and DEC. I am able to find the source matches between two data sets at a time. I have two questions about this. First of all, when I match my first data set to my second data set, they have 2240 matches, but when I match my first data set to my third data set, they have 3400 matches. My first data set is the one I want to match to specifically because it has the least amount of sources. How do I ensure that all three data sets all match each other (ie. contain the same sources), not just one of the other data sets? My second question is, now that I have the source matches, how do I apply this to the rest of the parameters (magnitude, flux etc.) in my data? After matching, I am able to output the matching RA and DEC values for each data set, but I don?t know how to apply the matches to the other 21 columns of data that correspond to these sources. In order for me to continue the project I must be able to use all of the data, not just RA and DEC. Below is the code that I have used to find my matches. I?ve been trying to search online for answers to these questions for days with no luck. I am not sure if this a good place to ask this, and if it isn?t then could someone direct me to a good forum for these types of questions? > > > > > import numpy as np > > my_csv1 = np.loadtxt(open("F435W.csv"), delimiter=",") > my_csv2 = np.loadtxt(open("F550M.csv"), delimiter=",") > > from astropy.coordinates import SkyCoord > from astropy import units as u > from astropy.coordinates import match_coordinates_sky > > c = SkyCoord(my_csv1[:, 12], my_csv1[:, 13], frame='icrs', unit='deg') > catalog = SkyCoord(my_csv2[:, 12], my_csv2[:, 13], frame='icrs', unit='deg') > > max_sep = 1.0*u.arcsec > idx, sep2d, _ = c.match_to_catalog_sky(catalog) > sep_constraint = sep2d < max_sep > c_matches = c[sep_constraint] > catalog_matches = catalog[idx[sep_constraint]] > > print (len(c_matches), len(catalog_matches)) > > > > Thank you, > > Samantha > > > > > _______________________________________________ > AstroPy mailing list > AstroPy at python.org > https://mail.python.org/mailman/listinfo/astropy -------------- next part -------------- An HTML attachment was scrubbed... URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: smime.p7s Type: application/pkcs7-signature Size: 3932 bytes Desc: not available URL: From ejsaiet at alaska.edu Wed Mar 27 12:36:33 2019 From: ejsaiet at alaska.edu (Eyal Saiet) Date: Wed, 27 Mar 2019 16:36:33 -0000 Subject: [AstroPy] fft_psd_tools and radialAverageBins() in astropy 3.1 In-Reply-To: References: Message-ID: Got it thanks for this explanation. Is image_tools not up-to-date? Are you associated with turbostat? Thanks again for your help! On Wed, Mar 27, 2019 at 2:30 AM Adam Ginsburg wrote: > The code you're pointing to is in the `image_tools` package, which is my > package. It's not part of astropy and it's not an official affiliate. It > uses the astropy-template, which is why the documentation looks similar, > but these tools have never been part of the astropy core package. > > For a somewhat more up-to-date version of the azimuthally averaged > power-spectrum, you should look at turbustat: > > https://turbustat.readthedocs.io/en/latest/api/turbustat.statistics.PowerSpectrum.html > > On Wed, Mar 20, 2019 at 5:03 AM Eyal Saiet wrote: > >> Hello, >> As can be seen below, astropy 2.7 has the class fft_psd_tools and the >> radialAverageBins() function. Looking at astropy 3.1, I cannot find the >> class and respected function, fft_psd_tools and adialAverageBins(). Was it >> deprecated in astropy 3.0? >> thanks >> >> [image: image.png] >> >> * The radially averaged power spectrum(RAPS) is s the >> direction-independent mean spectrum, i.e. the average of all possible >> directional power spectra. The radially averaged power spectrum provides a >> convenient means to view and compare information contained in 2-D spectra >> in 1-D. This function computes and plots the RAPS of an input matrix (does >> not consider corner values outside averaging radius). The image can be >> rectangular but must be 2-D (e.g., multi-color channel data is not >> supported). The spatial resolution of the data is also specified (https://www.mathworks.com/matlabcentral/fileexchange/23636-radially-averaged-power-spectrum-of-2d-real-valued-matrix >> ) >> >> Thanks >> -- >> >> Eyal >> >> _______________________________________________ >> AstroPy mailing list >> AstroPy at python.org >> https://mail.python.org/mailman/listinfo/astropy >> > > > -- > Adam Ginsburg > Jansky fellow, National Radio Astronomy Observatory > http://www.adamgginsburg.com/ > _______________________________________________ > AstroPy mailing list > AstroPy at python.org > https://mail.python.org/mailman/listinfo/astropy > -- Eyal Saiet Project manager Remote sensing and in-situ measurements Geophysical Institute University of Alaska Fairbanks Fairbanks, AK 99775 (907) 750 6555 (cell) The mind is not a vessel to be filled, but a fire to be kindled. Plutarch -------------- next part -------------- An HTML attachment was scrubbed... URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: image.png Type: image/png Size: 127927 bytes Desc: not available URL: