Public Member Functions | |
def | __init__ |
def | newfig |
def | nextfig |
def | endfig |
def | msg |
def | isquantity |
def | isdirection |
def | ismstp |
def | statim |
plot an image (optionally), and calculate its statistics | |
def | calc_pointings2 |
def | read_pointings |
def | write_pointings |
def | average_direction |
def | median_direction |
def | direction_splitter |
def | dir_s2m |
def | dir_m2s |
def | wrapang |
def | noisetemp |
========================== tsys ========================== | |
def | sensitivity |
def | setcfg |
def | ephemeris |
===================== ephemeris ========================== | |
def | readantenna |
def | tmgeod |
==================== geodesy ============================= | |
def | tconpc |
def | getdatum |
def | utm2long |
def | long2xyz |
def | xyz2long |
def | utm2xyz |
def | locxyz2itrf |
def | itrf2loc |
def | plotants |
def | cellsize |
helper function to get the pixel size from an image (positive increments) | |
def | spectral |
helper function to get the spectral size from an image | |
def | is4d |
def | modifymodel |
fit modelimage into a 4 coordinate image defined by the parameters | |
def | imclean |
image/clean subtask | |
def | flatimage |
def | convimage |
def | bandname |
def | polsettings |
def | applyRotate |
ALMA calcpointings. | |
def | isEven |
def | getTrianglePoints |
def | getTriangularTiling |
def | needsFiller |
def | getBaseTriangularTiling |
def | getShiftTriangularTiling |
Public Attributes | |
direction | |
verbose | |
centerfreq | |
bandwidth | |
totaltime | |
pmulti | |
pointings | |
ignoring line that has less than 3 elements | |
Static Public Attributes | |
tuple | f |
Helper function to read 4 columns text antenna table X, Y, Z, Diam. | |
string | line |
list | inx |
list | iny |
list | inz |
list | ind |
list | id |
int | nant |
dictionary | params |
if the line is a parameter line like coordsys=utms, then it stores that | |
tuple | line |
list | line |
tuple | paramlist |
tuple | splitline |
ignoring line that has less than 4 elements all coord systems should have x,y,z,diam,id, where xyz varies print line.split() | |
stnx | |
earth-centered XYZ i.e. | |
stny | |
stnz | |
list | stnx |
list | stny |
list | stnz |
list | zone |
expect easting, northing, elevation in m | |
list | datum |
list | nors |
vsave | |
tuple | meobs |
tuple | obs |
tuple | obslat |
tuple | obslon |
tuple | obsalt |
Definition at line 51 of file simutil.py.
def simutil.simutil.__init__ | ( | self, | |
direction = "" , |
|||
centerfreq = qa.quantity("245GHz") , |
|||
bandwidth = qa.quantity("1GHz") , |
|||
totaltime = qa.quantity("0h") , |
|||
verbose = False |
|||
) |
Definition at line 56 of file simutil.py.
def simutil.simutil.applyRotate | ( | self, | |
x, | |||
y, | |||
tcos, | |||
tsin | |||
) |
ALMA calcpointings.
Definition at line 2973 of file simutil.py.
Referenced by simutil.simutil.getBaseTriangularTiling(), simutil.simutil.getShiftTriangularTiling(), and simutil.simutil.getTrianglePoints().
def simutil.simutil.average_direction | ( | self, | |
directions = None |
|||
) |
Returns the average of directions as a string, and relative offsets
Definition at line 615 of file simutil.py.
References simutil.simutil.direction, simutil.simutil.direction_splitter(), and simutil.simutil.wrapang().
Referenced by simutil.simutil.dir_s2m(), and simutil.simutil.direction_splitter().
def simutil.simutil.bandname | ( | self, | |
freq | |||
) |
Given freq in GHz, return the silly and in some cases deliberately confusing band name that some people insist on using.
Definition at line 2898 of file simutil.py.
def simutil.simutil.calc_pointings2 | ( | self, | |
spacing, | |||
size, | |||
maptype = "hex" , |
|||
direction = None , |
|||
relmargin = 0.5 , |
|||
beam = 0. |
|||
) |
If direction is a list, simply returns direction and the number of pointings in it. Otherwise, returns a hexagonally packed list of pointings separated by spacing and fitting inside an area specified by direction and mapsize, as well as the number of pointings. The hexagonal packing starts with a horizontal row centered on direction, and the other rows alternate being horizontally offset by a half spacing.
Definition at line 341 of file simutil.py.
References simutil.simutil.direction, simutil.simutil.direction_splitter(), simutil.simutil.getTrianglePoints(), simutil.simutil.getTriangularTiling(), simutil.simutil.isdirection(), simutil.simutil.isquantity(), __casac__.quanta.quanta.isquantity(), simutil.simutil.msg(), gprof2dot.ParseError.msg, and simutil.simutil.verbose.
def simutil.simutil.cellsize | ( | self, | |
image | |||
) |
helper function to get the pixel size from an image (positive increments)
Definition at line 2069 of file simutil.py.
References irc_cs_task_regression.max, simutil.simutil.msg(), and gprof2dot.ParseError.msg.
Referenced by simutil.simutil.statim().
def simutil.simutil.convimage | ( | self, | |
modelflat, | |||
outflat, | |||
complist = "" |
|||
) |
Definition at line 2816 of file simutil.py.
References irc_cs_task_regression.max, simutil.simutil.msg(), gprof2dot.ParseError.msg, and simutil.simutil.verbose.
def simutil.simutil.dir_m2s | ( | self, | |
dir | |||
) |
Given a direction as a measure, return it as astring 'refcode lon lat'.
Definition at line 771 of file simutil.py.
References simutil.simutil.msg(), and gprof2dot.ParseError.msg.
def simutil.simutil.dir_s2m | ( | self, | |
direction = None |
|||
) |
Given a direction as a string 'refcode lon lat', return it as qa measure.
Definition at line 749 of file simutil.py.
References simutil.simutil.average_direction(), simutil.simutil.direction, simutil.simutil.msg(), gprof2dot.ParseError.msg, and simutil.simutil.verbose.
Referenced by simutil.simutil.modifymodel().
def simutil.simutil.direction_splitter | ( | self, | |
direction = None |
|||
) |
Given a direction, return its epoch, x, and y parts. Epoch will be '' if absent, or '%s ' % epoch if present. x and y will be angle qa's in degrees.
Definition at line 713 of file simutil.py.
References simutil.simutil.average_direction(), and simutil.simutil.direction.
Referenced by simutil.simutil.average_direction(), simutil.simutil.calc_pointings2(), simutil.simutil.ephemeris(), simutil.simutil.isdirection(), simutil.simutil.median_direction(), and simutil.simutil.modifymodel().
def simutil.simutil.endfig | ( | self, | |
show = True , |
|||
filename = "" |
|||
) |
Definition at line 99 of file simutil.py.
def simutil.simutil.ephemeris | ( | self, | |
date, | |||
usehourangle = True , |
|||
direction = None , |
|||
telescope = None , |
|||
ms = None |
|||
) |
===================== ephemeris ==========================
Definition at line 1218 of file simutil.py.
References simutil.simutil.direction, simutil.simutil.direction_splitter(), irc_cs_task_regression.max, simutil.simutil.msg(), gprof2dot.ParseError.msg, and simutil.simutil.totaltime.
def simutil.simutil.flatimage | ( | self, | |
image, | |||
complist = "" , |
|||
verbose = False |
|||
) |
Definition at line 2755 of file simutil.py.
References simutil.simutil.msg(), and gprof2dot.ParseError.msg.
Referenced by simutil.simutil.modifymodel().
def simutil.simutil.getBaseTriangularTiling | ( | self, | |
width, | |||
height, | |||
angle, | |||
spacing, | |||
pb | |||
) |
Definition at line 3062 of file simutil.py.
References simutil.simutil.applyRotate(), simutil.simutil.isEven(), and simutil.simutil.needsFiller().
Referenced by simutil.simutil.getTriangularTiling().
def simutil.simutil.getdatum | ( | self, | |
datumcode, | |||
verbose = False |
|||
) |
local datums and ellipsoids; take local earth-centered xyz coordinates, add dx,dy,dz to get wgs84 earth-centered
Definition at line 1655 of file simutil.py.
References simutil.simutil.msg(), and gprof2dot.ParseError.msg.
Referenced by simutil.simutil.long2xyz(), simutil.simutil.utm2long(), and simutil.simutil.xyz2long().
def simutil.simutil.getShiftTriangularTiling | ( | self, | |
width, | |||
height, | |||
angle, | |||
spacing, | |||
pb | |||
) |
Definition at line 3098 of file simutil.py.
References simutil.simutil.applyRotate(), simutil.simutil.isEven(), and simutil.simutil.needsFiller().
Referenced by simutil.simutil.getTriangularTiling().
def simutil.simutil.getTrianglePoints | ( | self, | |
width, | |||
height, | |||
angle, | |||
spacing | |||
) |
Definition at line 2983 of file simutil.py.
References simutil.simutil.applyRotate(), and simutil.simutil.isEven().
Referenced by simutil.simutil.calc_pointings2().
def simutil.simutil.getTriangularTiling | ( | self, | |
longlength, | |||
latlength, | |||
angle, | |||
spacing, | |||
pb | |||
) |
Definition at line 3032 of file simutil.py.
References simutil.simutil.getBaseTriangularTiling(), and simutil.simutil.getShiftTriangularTiling().
Referenced by simutil.simutil.calc_pointings2().
def simutil.simutil.imclean | ( | self, | |
mstoimage, | |||
imagename, | |||
cleanmode, | |||
cell, | |||
imsize, | |||
imcenter, | |||
niter, | |||
threshold, | |||
weighting, | |||
outertaper, | |||
stokes, | |||
sourcefieldlist = "" , |
|||
modelimage = "" , |
|||
mask = [] |
|||
) |
image/clean subtask
Definition at line 2566 of file simutil.py.
References simutil.simutil.msg(), gprof2dot.ParseError.msg, and simutil.simutil.verbose.
Referenced by simutil.simutil.modifymodel(), and simutil.simutil.sensitivity().
def simutil.simutil.is4d | ( | self, | |
image | |||
) |
Definition at line 2100 of file simutil.py.
References simutil.simutil.modifymodel().
def simutil.simutil.isdirection | ( | self, | |
s, | |||
halt = True |
|||
) |
Definition at line 172 of file simutil.py.
References simutil.simutil.direction_splitter(), simutil.simutil.msg(), and gprof2dot.ParseError.msg.
Referenced by simutil.simutil.calc_pointings2(), and simutil.simutil.modifymodel().
def simutil.simutil.isEven | ( | self, | |
num | |||
) |
Definition at line 2976 of file simutil.py.
Referenced by simutil.simutil.getBaseTriangularTiling(), simutil.simutil.getShiftTriangularTiling(), and simutil.simutil.getTrianglePoints().
def simutil.simutil.ismstp | ( | self, | |
s, | |||
halt = False |
|||
) |
Definition at line 192 of file simutil.py.
References simutil.simutil.msg(), and gprof2dot.ParseError.msg.
def simutil.simutil.isquantity | ( | self, | |
s, | |||
halt = True |
|||
) |
Definition at line 158 of file simutil.py.
References simutil.simutil.msg(), and gprof2dot.ParseError.msg.
Referenced by simutil.simutil.calc_pointings2(), simutil.simutil.modifymodel(), and simutil.simutil.sensitivity().
def simutil.simutil.itrf2loc | ( | self, | |
x, | |||
y, | |||
z, | |||
cx, | |||
cy, | |||
cz | |||
) |
itrf xyz and COFA cx,cy,cz -> latlon WGS84
Definition at line 1973 of file simutil.py.
References simutil.simutil.xyz2long().
Referenced by simutil.simutil.plotants().
def simutil.simutil.locxyz2itrf | ( | self, | |
lat, | |||
longitude, | |||
locx = 0.0 , |
|||
locy = 0.0 , |
|||
locz = 0.0 |
|||
) |
Returns the nominal ITRF (X, Y, Z) coordinates (m) for a point at "local" (x, y, z) (m) measured at geodetic latitude lat and longitude longitude (degrees). The ITRF frame used is not the official ITRF, just a right handed Cartesian system with X going through 0 latitude and 0 longitude, and Z going through the north pole. The "local" (x, y, z) are measured relative to the closest point to (lat, longitude) on the WGS84 reference ellipsoid, with z normal to the ellipsoid and y pointing north.
Definition at line 1940 of file simutil.py.
Referenced by simutil.simutil.sensitivity().
def simutil.simutil.long2xyz | ( | self, | |
long, | |||
lat, | |||
elevation, | |||
datum | |||
) |
Definition at line 1875 of file simutil.py.
References simutil.simutil.getdatum().
Referenced by simutil.simutil.utm2xyz().
def simutil.simutil.median_direction | ( | self, | |
directions = None |
|||
) |
Returns the median of directions as a string, and relative offsets
Definition at line 662 of file simutil.py.
References simutil.simutil.direction, simutil.simutil.direction_splitter(), and simutil.simutil.wrapang().
def simutil.simutil.modifymodel | ( | self, | |
inimage, | |||
outimage, | |||
inbright, | |||
indirection, | |||
incell, | |||
incenter, | |||
inwidth, | |||
innchan, | |||
flatimage = False |
|||
) |
fit modelimage into a 4 coordinate image defined by the parameters
Definition at line 2128 of file simutil.py.
References make_mmsdata.all, simutil.simutil.dir_s2m(), simutil.simutil.direction_splitter(), simutil.simutil.flatimage(), simutil.simutil.imclean(), simutil.simutil.isdirection(), simutil.simutil.isquantity(), __casac__.quanta.quanta.isquantity(), irc_cs_task_regression.max, simutil.simutil.msg(), gprof2dot.ParseError.msg, and simutil.simutil.verbose.
Referenced by simutil.simutil.is4d().
def simutil.simutil.msg | ( | self, | |
s, | |||
origin = None , |
|||
priority = None |
|||
) |
Definition at line 115 of file simutil.py.
Referenced by simutil.simutil.calc_pointings2(), simutil.simutil.cellsize(), simutil.simutil.convimage(), simutil.simutil.dir_m2s(), simutil.simutil.dir_s2m(), simutil.simutil.ephemeris(), simutil.simutil.flatimage(), simutil.simutil.getdatum(), simutil.simutil.imclean(), simutil.simutil.isdirection(), simutil.simutil.ismstp(), simutil.simutil.isquantity(), simutil.simutil.modifymodel(), simutil.simutil.newfig(), simutil.simutil.noisetemp(), simutil.simutil.read_pointings(), simutil.simutil.sensitivity(), simutil.simutil.statim(), and simutil.simutil.utm2long().
def simutil.simutil.needsFiller | ( | self, | |
length, | |||
spacing, | |||
bs, | |||
npoints | |||
) |
Definition at line 3056 of file simutil.py.
Referenced by simutil.simutil.getBaseTriangularTiling(), and simutil.simutil.getShiftTriangularTiling().
def simutil.simutil.newfig | ( | self, | |
multi = 0 , |
|||
show = True |
|||
) |
Definition at line 65 of file simutil.py.
References simutil.simutil.msg(), gprof2dot.ParseError.msg, and simutil.simutil.pmulti.
def simutil.simutil.nextfig | ( | self | ) |
Definition at line 84 of file simutil.py.
References simutil.simutil.pmulti.
def simutil.simutil.noisetemp | ( | self, | |
telescope = None , |
|||
freq = None , |
|||
diam = None , |
|||
epsilon = None |
|||
) |
========================== tsys ==========================
Noise temperature and efficiencies for several telescopes: ALMA, ACA, EVLA, VLA, and SMA Input: telescope name, frequency as a quantity string "300GHz", dish diameter (optional - knows diameters for arrays above) epsilon = rms surface accuracy in microns (also optional - this method contains the spec values for each telescope) Output: eta_p phase efficieny (from Ruze formula), eta_s spill (main beam) efficiency, eta_b geometrical blockage efficiency, eta_t taper efficiency, eta_q correlator efficiency including quantization, t_rx reciever temperature. antenna efficiency = eta_p * eta_s * eta_b * eta_t Notes: VLA correlator efficiency includes waveguide loss EVLA correlator efficiency is probably optimistic at 0.88
Definition at line 809 of file simutil.py.
References simutil.simutil.bandwidth, simutil.simutil.centerfreq, simutil.simutil.msg(), gprof2dot.ParseError.msg, simutil.simutil.sensitivity(), and simutil.simutil.verbose.
Referenced by simutil.simutil.sensitivity(), and simutil.simutil.wrapang().
def simutil.simutil.plotants | ( | self, | |
x, | |||
y, | |||
z, | |||
d, | |||
name | |||
) |
Definition at line 2012 of file simutil.py.
References simutil.simutil.itrf2loc(), and irc_cs_task_regression.max.
def simutil.simutil.polsettings | ( | self, | |
telescope, | |||
poltype = None , |
|||
listall = False |
|||
) |
Returns stokes parameters (for use as stokes in sm.setspwindow) and feed type (for use as mode in sm.setfeed). If poltype is not specified or recognized, a guess is made using telescope. Defaults to 'XX YY', 'perfect X Y' If listall is True, return the options instead.
Definition at line 2948 of file simutil.py.
Referenced by simutil.simutil.sensitivity().
def simutil.simutil.read_pointings | ( | self, | |
filename | |||
) |
read pointing list from file containing epoch, ra, dec, and scan time (optional,in sec). Parameter: filename: (str) the name of input file The input file (ASCII) should contain at least 3 fields separated by a space which specify positions with epoch, ra and dec (in dms or hms). The optional field, time, shoud be a list of decimal numbers which specifies integration time at each position in second. The lines which start with '#' is ignored and can be used as comment lines. Example of an input file: #Epoch RA DEC TIME(optional) J2000 23h59m28.10 -019d52m12.35 10.0 J2000 23h59m32.35 -019d52m12.35 10.0 J2000 23h59m36.61 -019d52m12.35 60.0
Definition at line 509 of file simutil.py.
References simutil.simutil.msg(), gprof2dot.ParseError.msg, and simutil.simutil.pointings.
def simutil.simutil.readantenna | ( | self, | |
antab = None |
|||
) |
def simutil.simutil.sensitivity | ( | self, | |
freq, | |||
bandwidth, | |||
etime, | |||
elevation, | |||
pwv = None , |
|||
telescope = None , |
|||
diam = None , |
|||
nant = None , |
|||
antennalist = None , |
|||
doimnoise = None , |
|||
integration = None , |
|||
debug = None , |
|||
method = "tsys-atm" , |
|||
tau0 = None , |
|||
t_sky = None |
|||
) |
Definition at line 962 of file simutil.py.
References simutil.simutil.imclean(), simutil.simutil.isquantity(), __casac__.quanta.quanta.isquantity(), simutil.simutil.locxyz2itrf(), irc_cs_task_regression.max, simutil.simutil.msg(), gprof2dot.ParseError.msg, simutil.simutil.noisetemp(), simutil.simutil.polsettings(), simutil.simutil.readantenna(), simutil.simutil.setcfg(), and simutil.simutil.verbose.
Referenced by simutil.simutil.noisetemp().
def simutil.simutil.setcfg | ( | self, | |
mysm, | |||
telescope, | |||
x, | |||
y, | |||
z, | |||
diam, | |||
padnames, | |||
posobs, | |||
mounttype = None |
|||
) |
Sets the antenna positions for the mysm sm instance, which should have already opened an MS, given telescope - telescope name x - array of X positions, i.e. stnx from readantenna y - array of Y positions, i.e. stny from readantenna z - array of Z positions, i.e. stnz from readantenna diam - numpy.array of antenna diameters, i.e. from readantenna padnames - list of pad names posobs - The observatory position as a measure. Optional: mounttype (Defaults to a guess based on telescope.) Returns the mounttype that it uses. Closes mysm and throws a ValueError if it can't set the configuration.
Definition at line 1169 of file simutil.py.
Referenced by simutil.simutil.sensitivity().
def simutil.simutil.spectral | ( | self, | |
image | |||
) |
helper function to get the spectral size from an image
Definition at line 2087 of file simutil.py.
def simutil.simutil.statim | ( | self, | |
image, | |||
plot = True , |
|||
incell = None , |
|||
disprange = None , |
|||
bar = True , |
|||
showstats = True |
|||
) |
plot an image (optionally), and calculate its statistics
Definition at line 225 of file simutil.py.
References simutil.simutil.cellsize(), simutil.simutil.msg(), gprof2dot.ParseError.msg, and simutil.simutil.verbose.
def simutil.simutil.tconpc | ( | self, | |
sf, | |||
orlim, | |||
er, | |||
esq, | |||
rf | |||
) |
transverse mercator projection *** conversion of grid coords to geodetic coords revised subroutine of t. vincenty feb. 25, 1985 converted from fortran r. indebetouw jan 2009 ********** symbols and definitions *********************** input: rf is the reciprocal flattening of ellipsoid esq = e squared (eccentricity?) er is the semi-major axis for grs-80 sf is the scale factor at the cm orlim is the southernmost parallel of latitude for which the northing coord is zero at the cm output: eps so is the meridional distance (times the sf) from the equator to southernmost parallel of lat. for the zone r is the radius of the rectifying sphere u0,u2,u4,u6,v0,v2,v4,v6 are precomputed constants for determination of meridional dist. from latitude **********************************************************
Definition at line 1592 of file simutil.py.
Referenced by simutil.simutil.utm2long().
def simutil.simutil.tmgeod | ( | self, | |
n, | |||
e, | |||
eps, | |||
cm, | |||
fe, | |||
sf, | |||
so, | |||
r, | |||
v0, | |||
v2, | |||
v4, | |||
v6, | |||
fn, | |||
er, | |||
esq | |||
) |
==================== geodesy =============================
Transverse Mercator Projection conversion of grid coords n,e to geodetic coords revised subroutine of t. vincenty feb. 25, 1985 converted from Fortran R Indebetouw Jan 2009 ********** symbols and definitions *********************** latitude positive north, longitude positive west. all angles are in radian measure. input: n,e are northing and easting coordinates respectively er is the semi-major axis of the ellipsoid esq is the square of the 1st eccentricity cm is the central meridian of the projection zone fe is the false easting value at the cm eps is the square of the 2nd eccentricity sf is the scale factor at the cm so is the meridional distance (times the sf) from the equator to southernmost parallel of lat. for the zone r is the radius of the rectifying sphere u0,u2,u4,u6,v0,v2,v4,v6 are precomputed constants for determination of meridianal dist. from latitude output: lat,lon are lat. and long. respectively conv is convergence kp point scale factor the formula used in this subroutine gives geodetic accuracy within zones of 7 degrees in east-west extent. within state transverse mercator projection zones, several minor terms of the equations may be omitted (see a separate ngs publication). if programmed in full, the subroutine can be used for computations in surveys extending over two zones.
Definition at line 1507 of file simutil.py.
Referenced by simutil.simutil.utm2long().
def simutil.simutil.utm2long | ( | self, | |
east, | |||
north, | |||
zone, | |||
datum, | |||
nors | |||
) |
this program converts universal transverse meractor coordinates to gps converted from fortran by r. indebetouw jan 2009. ri also added other datums and ellipsoids in a helper function header from original UTMS fortran program: * this program was originally written by e. carlson * subroutines tmgrid, tconst, tmgeod, tconpc, * were written by t. vincenty, ngs, in july 1984 . * the orginal program was written in september of 1988. * * this program was updated on febuary 16, 1989. the update was * having the option of saving and *81* record file. * * * this program was updated on april 3, 1990. the following update * were made: * 1. change from just a choice of nad27 of nad83 reference * ellipsoids to; clarke 1866, grs80/wgs84, international, and * allow for user defined other. * 2. allow use of latitudes in southern hemisphere and longitudes * up to 360 degrees west. * * this program was updated on december 1, 1993. the following update * was made: * 1. the northings would compute the right latitude in the southern * hemishpere. * 2. the computed latitude on longidutes would be either in e or w. * ***************************************************************** * * disclaimer * * * * this program and supporting information is furnished by the * * government of the united states of america, and is accepted and * * used by the recipient with the understanding that the united states * * government makes no warranties, express or implied, concerning the * * accuracy, completeness, reliability, or suitability of this * * program, of its constituent parts, or of any supporting data. * * * * the government of the united states of america shall be under no * * liability whatsoever resulting from any use of this program. this * * program should not be relied upon as the sole basis for solving a * * problem whose incorrect solution could result in injury to person * * or property. * * * * this program is property of the government of the united states * * of america. therefore, the recipient further agrees not to assert * * proprietary rights therein and not to represent this program to * * anyone as being other than a government program. * * * *********************************************************************** this is the driver program to compute latitudes and longitudes from the utms for each zone input: northing, easting zone, datum nors=N/S determined according to datum: er = equatorial radius of the ellipsoid (semi-major axis) rf = reciprocal of flatting of the ellipsod f = esq= e squared calculated according to longitude and zone: rad = radian conversion factor cm = central meridian ( computed using the longitude) sf = scale factor of central meridian ( always .9996 for utm) orlim = southernmost parallel of latitude ( always zero for utm) r, a, b, c, u, v, w = ellipsoid constants used for computing meridional distance from latitude so = meridional distance (multiplied by scale factor ) from the equator to the southernmost parallel of latitude ( always zero for utm)
Definition at line 1723 of file simutil.py.
References simutil.simutil.getdatum(), simutil.simutil.msg(), gprof2dot.ParseError.msg, simutil.simutil.tconpc(), simutil.simutil.tmgeod(), and simutil.simutil.verbose.
Referenced by simutil.simutil.utm2xyz().
def simutil.simutil.utm2xyz | ( | self, | |
easting, | |||
northing, | |||
elevation, | |||
zone, | |||
datum, | |||
nors | |||
) |
Definition at line 1931 of file simutil.py.
References simutil.simutil.long2xyz(), and simutil.simutil.utm2long().
def simutil.simutil.wrapang | ( | self, | |
ang, | |||
target, | |||
period = 360.0 |
|||
) |
Returns ang wrapped so that it is within +-period/2 of target.
Definition at line 784 of file simutil.py.
References simutil.simutil.noisetemp().
Referenced by simutil.simutil.average_direction(), and simutil.simutil.median_direction().
def simutil.simutil.write_pointings | ( | self, | |
filename, | |||
pointings, | |||
time = 1. |
|||
) |
write pointing list to file containing epoch, ra, dec, and scan time (optional,in sec). Example of an output file: #Epoch RA DEC TIME(optional) J2000 23h59m28.10 -019d52m12.35 10.0 J2000 23h59m32.35 -019d52m12.35 10.0 J2000 23h59m36.61 -019d52m12.35 60.0
Definition at line 577 of file simutil.py.
References tests.test_imcontsub.list.
def simutil.simutil.xyz2long | ( | self, | |
x, | |||
y, | |||
z, | |||
datum | |||
) |
Definition at line 1890 of file simutil.py.
References simutil.simutil.getdatum().
Referenced by simutil.simutil.itrf2loc().
Definition at line 60 of file simutil.py.
Referenced by simutil.simutil.noisetemp().
Definition at line 59 of file simutil.py.
Referenced by simutil.simutil.noisetemp().
list simutil.simutil.datum [static] |
Definition at line 1432 of file simutil.py.
Definition at line 57 of file simutil.py.
Referenced by task_sdimprocess.sdimprocess_worker.__execute_basket_weaving(), task_sdimprocess.sdimprocess_worker.__execute_press(), simutil.simutil.average_direction(), simutil.simutil.calc_pointings2(), simutil.simutil.dir_s2m(), simutil.simutil.direction_splitter(), simutil.simutil.ephemeris(), and simutil.simutil.median_direction().
tuple simutil.simutil.f [static] |
Helper function to read 4 columns text antenna table X, Y, Z, Diam.
Definition at line 1358 of file simutil.py.
list simutil.simutil.id [static] |
Definition at line 1365 of file simutil.py.
Referenced by gprof2dot.DotWriter.attr_list(), gprof2dot.DotWriter.edge(), and gprof2dot.DotWriter.node().
list simutil.simutil.ind [static] |
Definition at line 1364 of file simutil.py.
list simutil.simutil.inx [static] |
Definition at line 1361 of file simutil.py.
list simutil.simutil.iny [static] |
Definition at line 1362 of file simutil.py.
list simutil.simutil.inz [static] |
Definition at line 1363 of file simutil.py.
string simutil.simutil.line [static] |
Definition at line 1360 of file simutil.py.
tuple simutil.simutil.line [static] |
Definition at line 1371 of file simutil.py.
list simutil.simutil.line [static] |
Definition at line 1373 of file simutil.py.
tuple simutil.simutil.meobs [static] |
Definition at line 1455 of file simutil.py.
int simutil.simutil.nant [static] |
Definition at line 1366 of file simutil.py.
Referenced by task_sdtpimaging.sdtpimaging_worker.__execute_flag().
list simutil.simutil.nors [static] |
Definition at line 1437 of file simutil.py.
tuple simutil.simutil.obs [static] |
Definition at line 1459 of file simutil.py.
tuple simutil.simutil.obsalt [static] |
Definition at line 1462 of file simutil.py.
tuple simutil.simutil.obslat [static] |
Definition at line 1460 of file simutil.py.
tuple simutil.simutil.obslon [static] |
Definition at line 1461 of file simutil.py.
tuple simutil.simutil.paramlist [static] |
Definition at line 1374 of file simutil.py.
dictionary simutil.simutil.params [static] |
if the line is a parameter line like coordsys=utms, then it stores that
Definition at line 1368 of file simutil.py.
Referenced by task_tclean.PySynthesisImager.checkParameters(), task_tclean.PySynthesisImager.initialize(), and task_tclean.ParallelPySynthesisImager.initialize().
Definition at line 62 of file simutil.py.
Referenced by simutil.simutil.newfig(), and simutil.simutil.nextfig().
ignoring line that has less than 3 elements
Definition at line 495 of file simutil.py.
Referenced by simutil.simutil.read_pointings().
tuple simutil.simutil.splitline [static] |
ignoring line that has less than 4 elements all coord systems should have x,y,z,diam,id, where xyz varies print line.split()
Definition at line 1386 of file simutil.py.
simutil.simutil.stnx [static] |
list simutil.simutil.stnx [static] |
Definition at line 1420 of file simutil.py.
simutil.simutil.stny [static] |
Definition at line 1417 of file simutil.py.
list simutil.simutil.stny [static] |
Definition at line 1421 of file simutil.py.
simutil.simutil.stnz [static] |
Definition at line 1418 of file simutil.py.
list simutil.simutil.stnz [static] |
Definition at line 1422 of file simutil.py.
Definition at line 61 of file simutil.py.
Referenced by simutil.simutil.ephemeris().
Definition at line 58 of file simutil.py.
Referenced by simutil.simutil.calc_pointings2(), simutil.simutil.convimage(), simutil.simutil.dir_s2m(), simutil.simutil.imclean(), simutil.simutil.modifymodel(), simutil.simutil.noisetemp(), simutil.simutil.sensitivity(), simutil.simutil.statim(), and simutil.simutil.utm2long().
simutil.simutil.vsave [static] |
Definition at line 1443 of file simutil.py.
list simutil.simutil.zone [static] |
expect easting, northing, elevation in m
Definition at line 1427 of file simutil.py.