code
stringlengths
66
870k
docstring
stringlengths
19
26.7k
func_name
stringlengths
1
138
language
stringclasses
1 value
repo
stringlengths
7
68
path
stringlengths
5
324
url
stringlengths
46
389
license
stringclasses
7 values
def unhex(s): """Get the integer value of a hexadecimal number.""" bits = 0 for c in s: if '0' <= c <= '9': i = ord('0') elif 'a' <= c <= 'f': i = ord('a')-10 elif 'A' <= c <= 'F': i = ord('A')-10 else: break bits = bits*16 + (ord(c) - i) return bits
Get the integer value of a hexadecimal number.
unhex
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/quopri.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/quopri.py
MIT
def __init__(self, x=None): """Initialize an instance. Optional argument x controls seeding, as for Random.seed(). """ self.seed(x) self.gauss_next = None
Initialize an instance. Optional argument x controls seeding, as for Random.seed().
__init__
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/random.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/random.py
MIT
def seed(self, a=None): """Initialize internal state from hashable object. None or no argument seeds from current time or from an operating system specific randomness source if available. If a is not None or an int or long, hash(a) is used instead. """ if a is None: try: # Seed with enough bytes to span the 19937 bit # state space for the Mersenne Twister a = long(_hexlify(_urandom(2500)), 16) except NotImplementedError: import time a = long(time.time() * 256) # use fractional seconds super(Random, self).seed(a) self.gauss_next = None
Initialize internal state from hashable object. None or no argument seeds from current time or from an operating system specific randomness source if available. If a is not None or an int or long, hash(a) is used instead.
seed
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/random.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/random.py
MIT
def setstate(self, state): """Restore internal state from object returned by getstate().""" version = state[0] if version == 3: version, internalstate, self.gauss_next = state super(Random, self).setstate(internalstate) elif version == 2: version, internalstate, self.gauss_next = state # In version 2, the state was saved as signed ints, which causes # inconsistencies between 32/64-bit systems. The state is # really unsigned 32-bit ints, so we convert negative ints from # version 2 to positive longs for version 3. try: internalstate = tuple( long(x) % (2**32) for x in internalstate ) except ValueError, e: raise TypeError, e super(Random, self).setstate(internalstate) else: raise ValueError("state with version %s passed to " "Random.setstate() of version %s" % (version, self.VERSION))
Restore internal state from object returned by getstate().
setstate
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/random.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/random.py
MIT
def jumpahead(self, n): """Change the internal state to one that is likely far away from the current state. This method will not be in Py3.x, so it is better to simply reseed. """ # The super.jumpahead() method uses shuffling to change state, # so it needs a large and "interesting" n to work with. Here, # we use hashing to create a large n for the shuffle. s = repr(n) + repr(self.getstate()) n = int(_hashlib.new('sha512', s).hexdigest(), 16) super(Random, self).jumpahead(n)
Change the internal state to one that is likely far away from the current state. This method will not be in Py3.x, so it is better to simply reseed.
jumpahead
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/random.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/random.py
MIT
def randrange(self, start, stop=None, step=1, _int=int, _maxwidth=1L<<BPF): """Choose a random item from range(start, stop[, step]). This fixes the problem with randint() which includes the endpoint; in Python this is usually not what you want. """ # This code is a bit messy to make it fast for the # common case while still doing adequate error checking. istart = _int(start) if istart != start: raise ValueError, "non-integer arg 1 for randrange()" if stop is None: if istart > 0: if istart >= _maxwidth: return self._randbelow(istart) return _int(self.random() * istart) raise ValueError, "empty range for randrange()" # stop argument supplied. istop = _int(stop) if istop != stop: raise ValueError, "non-integer stop for randrange()" width = istop - istart if step == 1 and width > 0: # Note that # int(istart + self.random()*width) # instead would be incorrect. For example, consider istart # = -2 and istop = 0. Then the guts would be in # -2.0 to 0.0 exclusive on both ends (ignoring that random() # might return 0.0), and because int() truncates toward 0, the # final result would be -1 or 0 (instead of -2 or -1). # istart + int(self.random()*width) # would also be incorrect, for a subtler reason: the RHS # can return a long, and then randrange() would also return # a long, but we're supposed to return an int (for backward # compatibility). if width >= _maxwidth: return _int(istart + self._randbelow(width)) return _int(istart + _int(self.random()*width)) if step == 1: raise ValueError, "empty range for randrange() (%d,%d, %d)" % (istart, istop, width) # Non-unit step argument supplied. istep = _int(step) if istep != step: raise ValueError, "non-integer step for randrange()" if istep > 0: n = (width + istep - 1) // istep elif istep < 0: n = (width + istep + 1) // istep else: raise ValueError, "zero step for randrange()" if n <= 0: raise ValueError, "empty range for randrange()" if n >= _maxwidth: return istart + istep*self._randbelow(n) return istart + istep*_int(self.random() * n)
Choose a random item from range(start, stop[, step]). This fixes the problem with randint() which includes the endpoint; in Python this is usually not what you want.
randrange
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/random.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/random.py
MIT
def _randbelow(self, n, _log=_log, _int=int, _maxwidth=1L<<BPF, _Method=_MethodType, _BuiltinMethod=_BuiltinMethodType): """Return a random int in the range [0,n) Handles the case where n has more bits than returned by a single call to the underlying generator. """ try: getrandbits = self.getrandbits except AttributeError: pass else: # Only call self.getrandbits if the original random() builtin method # has not been overridden or if a new getrandbits() was supplied. # This assures that the two methods correspond. if type(self.random) is _BuiltinMethod or type(getrandbits) is _Method: k = _int(1.00001 + _log(n-1, 2.0)) # 2**k > n-1 > 2**(k-2) r = getrandbits(k) while r >= n: r = getrandbits(k) return r if n >= _maxwidth: _warn("Underlying random() generator does not supply \n" "enough bits to choose from a population range this large") return _int(self.random() * n)
Return a random int in the range [0,n) Handles the case where n has more bits than returned by a single call to the underlying generator.
_randbelow
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/random.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/random.py
MIT
def shuffle(self, x, random=None): """x, random=random.random -> shuffle list x in place; return None. Optional arg random is a 0-argument function returning a random float in [0.0, 1.0); by default, the standard random.random. """ if random is None: random = self.random _int = int for i in reversed(xrange(1, len(x))): # pick an element in x[:i+1] with which to exchange x[i] j = _int(random() * (i+1)) x[i], x[j] = x[j], x[i]
x, random=random.random -> shuffle list x in place; return None. Optional arg random is a 0-argument function returning a random float in [0.0, 1.0); by default, the standard random.random.
shuffle
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/random.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/random.py
MIT
def sample(self, population, k): """Chooses k unique random elements from a population sequence. Returns a new list containing elements from the population while leaving the original population unchanged. The resulting list is in selection order so that all sub-slices will also be valid random samples. This allows raffle winners (the sample) to be partitioned into grand prize and second place winners (the subslices). Members of the population need not be hashable or unique. If the population contains repeats, then each occurrence is a possible selection in the sample. To choose a sample in a range of integers, use xrange as an argument. This is especially fast and space efficient for sampling from a large population: sample(xrange(10000000), 60) """ # Sampling without replacement entails tracking either potential # selections (the pool) in a list or previous selections in a set. # When the number of selections is small compared to the # population, then tracking selections is efficient, requiring # only a small set and an occasional reselection. For # a larger number of selections, the pool tracking method is # preferred since the list takes less space than the # set and it doesn't suffer from frequent reselections. n = len(population) if not 0 <= k <= n: raise ValueError("sample larger than population") random = self.random _int = int result = [None] * k setsize = 21 # size of a small set minus size of an empty list if k > 5: setsize += 4 ** _ceil(_log(k * 3, 4)) # table size for big sets if n <= setsize or hasattr(population, "keys"): # An n-length list is smaller than a k-length set, or this is a # mapping type so the other algorithm wouldn't work. pool = list(population) for i in xrange(k): # invariant: non-selected at [0,n-i) j = _int(random() * (n-i)) result[i] = pool[j] pool[j] = pool[n-i-1] # move non-selected item into vacancy else: try: selected = set() selected_add = selected.add for i in xrange(k): j = _int(random() * n) while j in selected: j = _int(random() * n) selected_add(j) result[i] = population[j] except (TypeError, KeyError): # handle (at least) sets if isinstance(population, list): raise return self.sample(tuple(population), k) return result
Chooses k unique random elements from a population sequence. Returns a new list containing elements from the population while leaving the original population unchanged. The resulting list is in selection order so that all sub-slices will also be valid random samples. This allows raffle winners (the sample) to be partitioned into grand prize and second place winners (the subslices). Members of the population need not be hashable or unique. If the population contains repeats, then each occurrence is a possible selection in the sample. To choose a sample in a range of integers, use xrange as an argument. This is especially fast and space efficient for sampling from a large population: sample(xrange(10000000), 60)
sample
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/random.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/random.py
MIT
def uniform(self, a, b): "Get a random number in the range [a, b) or [a, b] depending on rounding." return a + (b-a) * self.random()
Get a random number in the range [a, b) or [a, b] depending on rounding.
uniform
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/random.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/random.py
MIT
def normalvariate(self, mu, sigma): """Normal distribution. mu is the mean, and sigma is the standard deviation. """ # mu = mean, sigma = standard deviation # Uses Kinderman and Monahan method. Reference: Kinderman, # A.J. and Monahan, J.F., "Computer generation of random # variables using the ratio of uniform deviates", ACM Trans # Math Software, 3, (1977), pp257-260. random = self.random while 1: u1 = random() u2 = 1.0 - random() z = NV_MAGICCONST*(u1-0.5)/u2 zz = z*z/4.0 if zz <= -_log(u2): break return mu + z*sigma
Normal distribution. mu is the mean, and sigma is the standard deviation.
normalvariate
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/random.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/random.py
MIT
def expovariate(self, lambd): """Exponential distribution. lambd is 1.0 divided by the desired mean. It should be nonzero. (The parameter would be called "lambda", but that is a reserved word in Python.) Returned values range from 0 to positive infinity if lambd is positive, and from negative infinity to 0 if lambd is negative. """ # lambd: rate lambd = 1/mean # ('lambda' is a Python reserved word) # we use 1-random() instead of random() to preclude the # possibility of taking the log of zero. return -_log(1.0 - self.random())/lambd
Exponential distribution. lambd is 1.0 divided by the desired mean. It should be nonzero. (The parameter would be called "lambda", but that is a reserved word in Python.) Returned values range from 0 to positive infinity if lambd is positive, and from negative infinity to 0 if lambd is negative.
expovariate
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/random.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/random.py
MIT
def vonmisesvariate(self, mu, kappa): """Circular data distribution. mu is the mean angle, expressed in radians between 0 and 2*pi, and kappa is the concentration parameter, which must be greater than or equal to zero. If kappa is equal to zero, this distribution reduces to a uniform random angle over the range 0 to 2*pi. """ # mu: mean angle (in radians between 0 and 2*pi) # kappa: concentration parameter kappa (>= 0) # if kappa = 0 generate uniform random angle # Based upon an algorithm published in: Fisher, N.I., # "Statistical Analysis of Circular Data", Cambridge # University Press, 1993. # Thanks to Magnus Kessler for a correction to the # implementation of step 4. random = self.random if kappa <= 1e-6: return TWOPI * random() s = 0.5 / kappa r = s + _sqrt(1.0 + s * s) while 1: u1 = random() z = _cos(_pi * u1) d = z / (r + z) u2 = random() if u2 < 1.0 - d * d or u2 <= (1.0 - d) * _exp(d): break q = 1.0 / r f = (q + z) / (1.0 + q * z) u3 = random() if u3 > 0.5: theta = (mu + _acos(f)) % TWOPI else: theta = (mu - _acos(f)) % TWOPI return theta
Circular data distribution. mu is the mean angle, expressed in radians between 0 and 2*pi, and kappa is the concentration parameter, which must be greater than or equal to zero. If kappa is equal to zero, this distribution reduces to a uniform random angle over the range 0 to 2*pi.
vonmisesvariate
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/random.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/random.py
MIT
def gammavariate(self, alpha, beta): """Gamma distribution. Not the gamma function! Conditions on the parameters are alpha > 0 and beta > 0. The probability distribution function is: x ** (alpha - 1) * math.exp(-x / beta) pdf(x) = -------------------------------------- math.gamma(alpha) * beta ** alpha """ # alpha > 0, beta > 0, mean is alpha*beta, variance is alpha*beta**2 # Warning: a few older sources define the gamma distribution in terms # of alpha > -1.0 if alpha <= 0.0 or beta <= 0.0: raise ValueError, 'gammavariate: alpha and beta must be > 0.0' random = self.random if alpha > 1.0: # Uses R.C.H. Cheng, "The generation of Gamma # variables with non-integral shape parameters", # Applied Statistics, (1977), 26, No. 1, p71-74 ainv = _sqrt(2.0 * alpha - 1.0) bbb = alpha - LOG4 ccc = alpha + ainv while 1: u1 = random() if not 1e-7 < u1 < .9999999: continue u2 = 1.0 - random() v = _log(u1/(1.0-u1))/ainv x = alpha*_exp(v) z = u1*u1*u2 r = bbb+ccc*v-x if r + SG_MAGICCONST - 4.5*z >= 0.0 or r >= _log(z): return x * beta elif alpha == 1.0: # expovariate(1) u = random() while u <= 1e-7: u = random() return -_log(u) * beta else: # alpha is between 0 and 1 (exclusive) # Uses ALGORITHM GS of Statistical Computing - Kennedy & Gentle while 1: u = random() b = (_e + alpha)/_e p = b*u if p <= 1.0: x = p ** (1.0/alpha) else: x = -_log((b-p)/alpha) u1 = random() if p > 1.0: if u1 <= x ** (alpha - 1.0): break elif u1 <= _exp(-x): break return x * beta
Gamma distribution. Not the gamma function! Conditions on the parameters are alpha > 0 and beta > 0. The probability distribution function is: x ** (alpha - 1) * math.exp(-x / beta) pdf(x) = -------------------------------------- math.gamma(alpha) * beta ** alpha
gammavariate
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/random.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/random.py
MIT
def gauss(self, mu, sigma): """Gaussian distribution. mu is the mean, and sigma is the standard deviation. This is slightly faster than the normalvariate() function. Not thread-safe without a lock around calls. """ # When x and y are two variables from [0, 1), uniformly # distributed, then # # cos(2*pi*x)*sqrt(-2*log(1-y)) # sin(2*pi*x)*sqrt(-2*log(1-y)) # # are two *independent* variables with normal distribution # (mu = 0, sigma = 1). # (Lambert Meertens) # (corrected version; bug discovered by Mike Miller, fixed by LM) # Multithreading note: When two threads call this function # simultaneously, it is possible that they will receive the # same return value. The window is very small though. To # avoid this, you have to use a lock around all calls. (I # didn't want to slow this down in the serial case by using a # lock here.) random = self.random z = self.gauss_next self.gauss_next = None if z is None: x2pi = random() * TWOPI g2rad = _sqrt(-2.0 * _log(1.0 - random())) z = _cos(x2pi) * g2rad self.gauss_next = _sin(x2pi) * g2rad return mu + z*sigma
Gaussian distribution. mu is the mean, and sigma is the standard deviation. This is slightly faster than the normalvariate() function. Not thread-safe without a lock around calls.
gauss
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/random.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/random.py
MIT
def betavariate(self, alpha, beta): """Beta distribution. Conditions on the parameters are alpha > 0 and beta > 0. Returned values range between 0 and 1. """ # This version due to Janne Sinkkonen, and matches all the std # texts (e.g., Knuth Vol 2 Ed 3 pg 134 "the beta distribution"). y = self.gammavariate(alpha, 1.) if y == 0: return 0.0 else: return y / (y + self.gammavariate(beta, 1.))
Beta distribution. Conditions on the parameters are alpha > 0 and beta > 0. Returned values range between 0 and 1.
betavariate
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/random.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/random.py
MIT
def paretovariate(self, alpha): """Pareto distribution. alpha is the shape parameter.""" # Jain, pg. 495 u = 1.0 - self.random() return 1.0 / pow(u, 1.0/alpha)
Pareto distribution. alpha is the shape parameter.
paretovariate
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/random.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/random.py
MIT
def weibullvariate(self, alpha, beta): """Weibull distribution. alpha is the scale parameter and beta is the shape parameter. """ # Jain, pg. 499; bug fix courtesy Bill Arms u = 1.0 - self.random() return alpha * pow(-_log(u), 1.0/beta)
Weibull distribution. alpha is the scale parameter and beta is the shape parameter.
weibullvariate
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/random.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/random.py
MIT
def seed(self, a=None): """Initialize internal state from hashable object. None or no argument seeds from current time or from an operating system specific randomness source if available. If a is not None or an int or long, hash(a) is used instead. If a is an int or long, a is used directly. Distinct values between 0 and 27814431486575L inclusive are guaranteed to yield distinct internal states (this guarantee is specific to the default Wichmann-Hill generator). """ if a is None: try: a = long(_hexlify(_urandom(16)), 16) except NotImplementedError: import time a = long(time.time() * 256) # use fractional seconds if not isinstance(a, (int, long)): a = hash(a) a, x = divmod(a, 30268) a, y = divmod(a, 30306) a, z = divmod(a, 30322) self._seed = int(x)+1, int(y)+1, int(z)+1 self.gauss_next = None
Initialize internal state from hashable object. None or no argument seeds from current time or from an operating system specific randomness source if available. If a is not None or an int or long, hash(a) is used instead. If a is an int or long, a is used directly. Distinct values between 0 and 27814431486575L inclusive are guaranteed to yield distinct internal states (this guarantee is specific to the default Wichmann-Hill generator).
seed
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/random.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/random.py
MIT
def random(self): """Get the next random number in the range [0.0, 1.0).""" # Wichman-Hill random number generator. # # Wichmann, B. A. & Hill, I. D. (1982) # Algorithm AS 183: # An efficient and portable pseudo-random number generator # Applied Statistics 31 (1982) 188-190 # # see also: # Correction to Algorithm AS 183 # Applied Statistics 33 (1984) 123 # # McLeod, A. I. (1985) # A remark on Algorithm AS 183 # Applied Statistics 34 (1985),198-200 # This part is thread-unsafe: # BEGIN CRITICAL SECTION x, y, z = self._seed x = (171 * x) % 30269 y = (172 * y) % 30307 z = (170 * z) % 30323 self._seed = x, y, z # END CRITICAL SECTION # Note: on a platform using IEEE-754 double arithmetic, this can # never return 0.0 (asserted by Tim; proof too long for a comment). return (x/30269.0 + y/30307.0 + z/30323.0) % 1.0
Get the next random number in the range [0.0, 1.0).
random
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/random.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/random.py
MIT
def setstate(self, state): """Restore internal state from object returned by getstate().""" version = state[0] if version == 1: version, self._seed, self.gauss_next = state else: raise ValueError("state with version %s passed to " "Random.setstate() of version %s" % (version, self.VERSION))
Restore internal state from object returned by getstate().
setstate
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/random.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/random.py
MIT
def jumpahead(self, n): """Act as if n calls to random() were made, but quickly. n is an int, greater than or equal to 0. Example use: If you have 2 threads and know that each will consume no more than a million random numbers, create two Random objects r1 and r2, then do r2.setstate(r1.getstate()) r2.jumpahead(1000000) Then r1 and r2 will use guaranteed-disjoint segments of the full period. """ if not n >= 0: raise ValueError("n must be >= 0") x, y, z = self._seed x = int(x * pow(171, n, 30269)) % 30269 y = int(y * pow(172, n, 30307)) % 30307 z = int(z * pow(170, n, 30323)) % 30323 self._seed = x, y, z
Act as if n calls to random() were made, but quickly. n is an int, greater than or equal to 0. Example use: If you have 2 threads and know that each will consume no more than a million random numbers, create two Random objects r1 and r2, then do r2.setstate(r1.getstate()) r2.jumpahead(1000000) Then r1 and r2 will use guaranteed-disjoint segments of the full period.
jumpahead
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/random.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/random.py
MIT
def __whseed(self, x=0, y=0, z=0): """Set the Wichmann-Hill seed from (x, y, z). These must be integers in the range [0, 256). """ if not type(x) == type(y) == type(z) == int: raise TypeError('seeds must be integers') if not (0 <= x < 256 and 0 <= y < 256 and 0 <= z < 256): raise ValueError('seeds must be in range(0, 256)') if 0 == x == y == z: # Initialize from current time import time t = long(time.time() * 256) t = int((t&0xffffff) ^ (t>>24)) t, x = divmod(t, 256) t, y = divmod(t, 256) t, z = divmod(t, 256) # Zero is a poor seed, so substitute 1 self._seed = (x or 1, y or 1, z or 1) self.gauss_next = None
Set the Wichmann-Hill seed from (x, y, z). These must be integers in the range [0, 256).
__whseed
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/random.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/random.py
MIT
def whseed(self, a=None): """Seed from hashable object's hash code. None or no argument seeds from current time. It is not guaranteed that objects with distinct hash codes lead to distinct internal states. This is obsolete, provided for compatibility with the seed routine used prior to Python 2.1. Use the .seed() method instead. """ if a is None: self.__whseed() return a = hash(a) a, x = divmod(a, 256) a, y = divmod(a, 256) a, z = divmod(a, 256) x = (x + a) % 256 or 1 y = (y + a) % 256 or 1 z = (z + a) % 256 or 1 self.__whseed(x, y, z)
Seed from hashable object's hash code. None or no argument seeds from current time. It is not guaranteed that objects with distinct hash codes lead to distinct internal states. This is obsolete, provided for compatibility with the seed routine used prior to Python 2.1. Use the .seed() method instead.
whseed
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/random.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/random.py
MIT
def getrandbits(self, k): """getrandbits(k) -> x. Generates a long int with k random bits.""" if k <= 0: raise ValueError('number of bits must be greater than zero') if k != int(k): raise TypeError('number of bits should be an integer') bytes = (k + 7) // 8 # bits / 8 and rounded up x = long(_hexlify(_urandom(bytes)), 16) return x >> (bytes * 8 - k) # trim excess bits
getrandbits(k) -> x. Generates a long int with k random bits.
getrandbits
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/random.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/random.py
MIT
def _notimplemented(self, *args, **kwds): "Method should not be called for a system random number generator." raise NotImplementedError('System entropy source does not have state.')
Method should not be called for a system random number generator.
_notimplemented
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/random.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/random.py
MIT
def compile(pattern, flags=0): "Compile a regular expression pattern, returning a pattern object." return _compile(pattern, flags)
Compile a regular expression pattern, returning a pattern object.
compile
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/re.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/re.py
MIT
def template(pattern, flags=0): "Compile a template pattern, returning a pattern object" return _compile(pattern, flags|T)
Compile a template pattern, returning a pattern object
template
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/re.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/re.py
MIT
def escape(pattern): "Escape all non-alphanumeric characters in pattern." s = list(pattern) alphanum = _alphanum for i, c in enumerate(pattern): if c not in alphanum: if c == "\000": s[i] = "\\000" else: s[i] = "\\" + c return pattern[:0].join(s)
Escape all non-alphanumeric characters in pattern.
escape
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/re.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/re.py
MIT
def r_exec(self, code): """Execute code within a restricted environment. The code parameter must either be a string containing one or more lines of Python code, or a compiled code object, which will be executed in the restricted environment's __main__ module. """ m = self.add_module('__main__') exec code in m.__dict__
Execute code within a restricted environment. The code parameter must either be a string containing one or more lines of Python code, or a compiled code object, which will be executed in the restricted environment's __main__ module.
r_exec
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/rexec.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/rexec.py
MIT
def r_eval(self, code): """Evaluate code within a restricted environment. The code parameter must either be a string containing a Python expression, or a compiled code object, which will be evaluated in the restricted environment's __main__ module. The value of the expression or code object will be returned. """ m = self.add_module('__main__') return eval(code, m.__dict__)
Evaluate code within a restricted environment. The code parameter must either be a string containing a Python expression, or a compiled code object, which will be evaluated in the restricted environment's __main__ module. The value of the expression or code object will be returned.
r_eval
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/rexec.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/rexec.py
MIT
def r_open(self, file, mode='r', buf=-1): """Method called when open() is called in the restricted environment. The arguments are identical to those of the open() function, and a file object (or a class instance compatible with file objects) should be returned. RExec's default behaviour is allow opening any file for reading, but forbidding any attempt to write a file. This method is implicitly called by code executing in the restricted environment. Overriding this method in a subclass is used to change the policies enforced by a restricted environment. """ mode = str(mode) if mode not in ('r', 'rb'): raise IOError, "can't open files for writing in restricted mode" return open(file, mode, buf)
Method called when open() is called in the restricted environment. The arguments are identical to those of the open() function, and a file object (or a class instance compatible with file objects) should be returned. RExec's default behaviour is allow opening any file for reading, but forbidding any attempt to write a file. This method is implicitly called by code executing in the restricted environment. Overriding this method in a subclass is used to change the policies enforced by a restricted environment.
r_open
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/rexec.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/rexec.py
MIT
def __init__(self, fp, seekable = 1): """Initialize the class instance and read the headers.""" if seekable == 1: # Exercise tell() to make sure it works # (and then assume seek() works, too) try: fp.tell() except (AttributeError, IOError): seekable = 0 self.fp = fp self.seekable = seekable self.startofheaders = None self.startofbody = None # if self.seekable: try: self.startofheaders = self.fp.tell() except IOError: self.seekable = 0 # self.readheaders() # if self.seekable: try: self.startofbody = self.fp.tell() except IOError: self.seekable = 0
Initialize the class instance and read the headers.
__init__
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/rfc822.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/rfc822.py
MIT
def rewindbody(self): """Rewind the file to the start of the body (if seekable).""" if not self.seekable: raise IOError, "unseekable file" self.fp.seek(self.startofbody)
Rewind the file to the start of the body (if seekable).
rewindbody
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/rfc822.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/rfc822.py
MIT
def readheaders(self): """Read header lines. Read header lines up to the entirely blank line that terminates them. The (normally blank) line that ends the headers is skipped, but not included in the returned list. If a non-header line ends the headers, (which is an error), an attempt is made to backspace over it; it is never included in the returned list. The variable self.status is set to the empty string if all went well, otherwise it is an error message. The variable self.headers is a completely uninterpreted list of lines contained in the header (so printing them will reproduce the header exactly as it appears in the file). """ self.dict = {} self.unixfrom = '' self.headers = lst = [] self.status = '' headerseen = "" firstline = 1 startofline = unread = tell = None if hasattr(self.fp, 'unread'): unread = self.fp.unread elif self.seekable: tell = self.fp.tell while 1: if tell: try: startofline = tell() except IOError: startofline = tell = None self.seekable = 0 line = self.fp.readline() if not line: self.status = 'EOF in headers' break # Skip unix From name time lines if firstline and line.startswith('From '): self.unixfrom = self.unixfrom + line continue firstline = 0 if headerseen and line[0] in ' \t': # It's a continuation line. lst.append(line) x = (self.dict[headerseen] + "\n " + line.strip()) self.dict[headerseen] = x.strip() continue elif self.iscomment(line): # It's a comment. Ignore it. continue elif self.islast(line): # Note! No pushback here! The delimiter line gets eaten. break headerseen = self.isheader(line) if headerseen: # It's a legal header line, save it. lst.append(line) self.dict[headerseen] = line[len(headerseen)+1:].strip() continue elif headerseen is not None: # An empty header name. These aren't allowed in HTTP, but it's # probably a benign mistake. Don't add the header, just keep # going. continue else: # It's not a header line; throw it back and stop here. if not self.dict: self.status = 'No headers' else: self.status = 'Non-header line where header expected' # Try to undo the read. if unread: unread(line) elif tell: self.fp.seek(startofline) else: self.status = self.status + '; bad seek' break
Read header lines. Read header lines up to the entirely blank line that terminates them. The (normally blank) line that ends the headers is skipped, but not included in the returned list. If a non-header line ends the headers, (which is an error), an attempt is made to backspace over it; it is never included in the returned list. The variable self.status is set to the empty string if all went well, otherwise it is an error message. The variable self.headers is a completely uninterpreted list of lines contained in the header (so printing them will reproduce the header exactly as it appears in the file).
readheaders
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/rfc822.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/rfc822.py
MIT
def isheader(self, line): """Determine whether a given line is a legal header. This method should return the header name, suitably canonicalized. You may override this method in order to use Message parsing on tagged data in RFC 2822-like formats with special header formats. """ i = line.find(':') if i > -1: return line[:i].lower() return None
Determine whether a given line is a legal header. This method should return the header name, suitably canonicalized. You may override this method in order to use Message parsing on tagged data in RFC 2822-like formats with special header formats.
isheader
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/rfc822.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/rfc822.py
MIT
def getallmatchingheaders(self, name): """Find all header lines matching a given header name. Look through the list of headers and find all lines matching a given header name (and their continuation lines). A list of the lines is returned, without interpretation. If the header does not occur, an empty list is returned. If the header occurs multiple times, all occurrences are returned. Case is not important in the header name. """ name = name.lower() + ':' n = len(name) lst = [] hit = 0 for line in self.headers: if line[:n].lower() == name: hit = 1 elif not line[:1].isspace(): hit = 0 if hit: lst.append(line) return lst
Find all header lines matching a given header name. Look through the list of headers and find all lines matching a given header name (and their continuation lines). A list of the lines is returned, without interpretation. If the header does not occur, an empty list is returned. If the header occurs multiple times, all occurrences are returned. Case is not important in the header name.
getallmatchingheaders
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/rfc822.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/rfc822.py
MIT
def getfirstmatchingheader(self, name): """Get the first header line matching name. This is similar to getallmatchingheaders, but it returns only the first matching header (and its continuation lines). """ name = name.lower() + ':' n = len(name) lst = [] hit = 0 for line in self.headers: if hit: if not line[:1].isspace(): break elif line[:n].lower() == name: hit = 1 if hit: lst.append(line) return lst
Get the first header line matching name. This is similar to getallmatchingheaders, but it returns only the first matching header (and its continuation lines).
getfirstmatchingheader
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/rfc822.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/rfc822.py
MIT
def getrawheader(self, name): """A higher-level interface to getfirstmatchingheader(). Return a string containing the literal text of the header but with the keyword stripped. All leading, trailing and embedded whitespace is kept in the string, however. Return None if the header does not occur. """ lst = self.getfirstmatchingheader(name) if not lst: return None lst[0] = lst[0][len(name) + 1:] return ''.join(lst)
A higher-level interface to getfirstmatchingheader(). Return a string containing the literal text of the header but with the keyword stripped. All leading, trailing and embedded whitespace is kept in the string, however. Return None if the header does not occur.
getrawheader
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/rfc822.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/rfc822.py
MIT
def getheaders(self, name): """Get all values for a header. This returns a list of values for headers given more than once; each value in the result list is stripped in the same way as the result of getheader(). If the header is not given, return an empty list. """ result = [] current = '' have_header = 0 for s in self.getallmatchingheaders(name): if s[0].isspace(): if current: current = "%s\n %s" % (current, s.strip()) else: current = s.strip() else: if have_header: result.append(current) current = s[s.find(":") + 1:].strip() have_header = 1 if have_header: result.append(current) return result
Get all values for a header. This returns a list of values for headers given more than once; each value in the result list is stripped in the same way as the result of getheader(). If the header is not given, return an empty list.
getheaders
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/rfc822.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/rfc822.py
MIT
def getaddr(self, name): """Get a single address from a header, as a tuple. An example return value: ('Guido van Rossum', '[email protected]') """ # New, by Ben Escoto alist = self.getaddrlist(name) if alist: return alist[0] else: return (None, None)
Get a single address from a header, as a tuple. An example return value: ('Guido van Rossum', '[email protected]')
getaddr
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/rfc822.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/rfc822.py
MIT
def getaddrlist(self, name): """Get a list of addresses from a header. Retrieves a list of addresses from a header, where each address is a tuple as returned by getaddr(). Scans all named headers, so it works properly with multiple To: or Cc: headers for example. """ raw = [] for h in self.getallmatchingheaders(name): if h[0] in ' \t': raw.append(h) else: if raw: raw.append(', ') i = h.find(':') if i > 0: addr = h[i+1:] raw.append(addr) alladdrs = ''.join(raw) a = AddressList(alladdrs) return a.addresslist
Get a list of addresses from a header. Retrieves a list of addresses from a header, where each address is a tuple as returned by getaddr(). Scans all named headers, so it works properly with multiple To: or Cc: headers for example.
getaddrlist
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/rfc822.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/rfc822.py
MIT
def getdate(self, name): """Retrieve a date field from a header. Retrieves a date field from the named header, returning a tuple compatible with time.mktime(). """ try: data = self[name] except KeyError: return None return parsedate(data)
Retrieve a date field from a header. Retrieves a date field from the named header, returning a tuple compatible with time.mktime().
getdate
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/rfc822.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/rfc822.py
MIT
def getdate_tz(self, name): """Retrieve a date field from a header as a 10-tuple. The first 9 elements make up a tuple compatible with time.mktime(), and the 10th is the offset of the poster's time zone from GMT/UTC. """ try: data = self[name] except KeyError: return None return parsedate_tz(data)
Retrieve a date field from a header as a 10-tuple. The first 9 elements make up a tuple compatible with time.mktime(), and the 10th is the offset of the poster's time zone from GMT/UTC.
getdate_tz
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/rfc822.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/rfc822.py
MIT
def __setitem__(self, name, value): """Set the value of a header. Note: This is not a perfect inversion of __getitem__, because any changed headers get stuck at the end of the raw-headers list rather than where the altered header was. """ del self[name] # Won't fail if it doesn't exist self.dict[name.lower()] = value text = name + ": " + value for line in text.split("\n"): self.headers.append(line + "\n")
Set the value of a header. Note: This is not a perfect inversion of __getitem__, because any changed headers get stuck at the end of the raw-headers list rather than where the altered header was.
__setitem__
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/rfc822.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/rfc822.py
MIT
def __delitem__(self, name): """Delete all occurrences of a specific header, if it is present.""" name = name.lower() if not name in self.dict: return del self.dict[name] name = name + ':' n = len(name) lst = [] hit = 0 for i in range(len(self.headers)): line = self.headers[i] if line[:n].lower() == name: hit = 1 elif not line[:1].isspace(): hit = 0 if hit: lst.append(i) for i in reversed(lst): del self.headers[i]
Delete all occurrences of a specific header, if it is present.
__delitem__
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/rfc822.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/rfc822.py
MIT
def parseaddr(address): """Parse an address into a (realname, mailaddr) tuple.""" a = AddressList(address) lst = a.addresslist if not lst: return (None, None) return lst[0]
Parse an address into a (realname, mailaddr) tuple.
parseaddr
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/rfc822.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/rfc822.py
MIT
def __init__(self, field): """Initialize a new instance. `field' is an unparsed address header field, containing one or more addresses. """ self.specials = '()<>@,:;.\"[]' self.pos = 0 self.LWS = ' \t' self.CR = '\r\n' self.atomends = self.specials + self.LWS + self.CR # Note that RFC 2822 now specifies `.' as obs-phrase, meaning that it # is obsolete syntax. RFC 2822 requires that we recognize obsolete # syntax, so allow dots in phrases. self.phraseends = self.atomends.replace('.', '') self.field = field self.commentlist = []
Initialize a new instance. `field' is an unparsed address header field, containing one or more addresses.
__init__
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/rfc822.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/rfc822.py
MIT
def gotonext(self): """Parse up to the start of the next address.""" while self.pos < len(self.field): if self.field[self.pos] in self.LWS + '\n\r': self.pos = self.pos + 1 elif self.field[self.pos] == '(': self.commentlist.append(self.getcomment()) else: break
Parse up to the start of the next address.
gotonext
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/rfc822.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/rfc822.py
MIT
def getaddrlist(self): """Parse all addresses. Returns a list containing all of the addresses. """ result = [] ad = self.getaddress() while ad: result += ad ad = self.getaddress() return result
Parse all addresses. Returns a list containing all of the addresses.
getaddrlist
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/rfc822.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/rfc822.py
MIT
def getrouteaddr(self): """Parse a route address (Return-path value). This method just skips all the route stuff and returns the addrspec. """ if self.field[self.pos] != '<': return expectroute = 0 self.pos += 1 self.gotonext() adlist = "" while self.pos < len(self.field): if expectroute: self.getdomain() expectroute = 0 elif self.field[self.pos] == '>': self.pos += 1 break elif self.field[self.pos] == '@': self.pos += 1 expectroute = 1 elif self.field[self.pos] == ':': self.pos += 1 else: adlist = self.getaddrspec() self.pos += 1 break self.gotonext() return adlist
Parse a route address (Return-path value). This method just skips all the route stuff and returns the addrspec.
getrouteaddr
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/rfc822.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/rfc822.py
MIT
def getdomain(self): """Get the complete domain name from an address.""" sdlist = [] while self.pos < len(self.field): if self.field[self.pos] in self.LWS: self.pos += 1 elif self.field[self.pos] == '(': self.commentlist.append(self.getcomment()) elif self.field[self.pos] == '[': sdlist.append(self.getdomainliteral()) elif self.field[self.pos] == '.': self.pos += 1 sdlist.append('.') elif self.field[self.pos] in self.atomends: break else: sdlist.append(self.getatom()) return ''.join(sdlist)
Get the complete domain name from an address.
getdomain
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/rfc822.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/rfc822.py
MIT
def getphraselist(self): """Parse a sequence of RFC 2822 phrases. A phrase is a sequence of words, which are in turn either RFC 2822 atoms or quoted-strings. Phrases are canonicalized by squeezing all runs of continuous whitespace into one space. """ plist = [] while self.pos < len(self.field): if self.field[self.pos] in self.LWS: self.pos += 1 elif self.field[self.pos] == '"': plist.append(self.getquote()) elif self.field[self.pos] == '(': self.commentlist.append(self.getcomment()) elif self.field[self.pos] in self.phraseends: break else: plist.append(self.getatom(self.phraseends)) return plist
Parse a sequence of RFC 2822 phrases. A phrase is a sequence of words, which are in turn either RFC 2822 atoms or quoted-strings. Phrases are canonicalized by squeezing all runs of continuous whitespace into one space.
getphraselist
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/rfc822.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/rfc822.py
MIT
def dump_address_pair(pair): """Dump a (name, address) pair in a canonicalized form.""" if pair[0]: return '"' + pair[0] + '" <' + pair[1] + '>' else: return pair[1]
Dump a (name, address) pair in a canonicalized form.
dump_address_pair
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/rfc822.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/rfc822.py
MIT
def parsedate_tz(data): """Convert a date string to a time tuple. Accounts for military timezones. """ if not data: return None data = data.split() if data[0][-1] in (',', '.') or data[0].lower() in _daynames: # There's a dayname here. Skip it del data[0] else: # no space after the "weekday,"? i = data[0].rfind(',') if i >= 0: data[0] = data[0][i+1:] if len(data) == 3: # RFC 850 date, deprecated stuff = data[0].split('-') if len(stuff) == 3: data = stuff + data[1:] if len(data) == 4: s = data[3] i = s.find('+') if i > 0: data[3:] = [s[:i], s[i+1:]] else: data.append('') # Dummy tz if len(data) < 5: return None data = data[:5] [dd, mm, yy, tm, tz] = data mm = mm.lower() if not mm in _monthnames: dd, mm = mm, dd.lower() if not mm in _monthnames: return None mm = _monthnames.index(mm)+1 if mm > 12: mm = mm - 12 if dd[-1] == ',': dd = dd[:-1] i = yy.find(':') if i > 0: yy, tm = tm, yy if yy[-1] == ',': yy = yy[:-1] if not yy[0].isdigit(): yy, tz = tz, yy if tm[-1] == ',': tm = tm[:-1] tm = tm.split(':') if len(tm) == 2: [thh, tmm] = tm tss = '0' elif len(tm) == 3: [thh, tmm, tss] = tm else: return None try: yy = int(yy) dd = int(dd) thh = int(thh) tmm = int(tmm) tss = int(tss) except ValueError: return None tzoffset = None tz = tz.upper() if tz in _timezones: tzoffset = _timezones[tz] else: try: tzoffset = int(tz) except ValueError: pass # Convert a timezone offset into seconds ; -0500 -> -18000 if tzoffset: if tzoffset < 0: tzsign = -1 tzoffset = -tzoffset else: tzsign = 1 tzoffset = tzsign * ( (tzoffset//100)*3600 + (tzoffset % 100)*60) return (yy, mm, dd, thh, tmm, tss, 0, 1, 0, tzoffset)
Convert a date string to a time tuple. Accounts for military timezones.
parsedate_tz
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/rfc822.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/rfc822.py
MIT
def parsedate(data): """Convert a time string to a time tuple.""" t = parsedate_tz(data) if t is None: return t return t[:9]
Convert a time string to a time tuple.
parsedate
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/rfc822.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/rfc822.py
MIT
def mktime_tz(data): """Turn a 10-tuple as returned by parsedate_tz() into a UTC timestamp.""" if data[9] is None: # No zone info, so localtime is better assumption than GMT return time.mktime(data[:8] + (-1,)) else: t = time.mktime(data[:8] + (0,)) return t - data[9] - time.timezone
Turn a 10-tuple as returned by parsedate_tz() into a UTC timestamp.
mktime_tz
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/rfc822.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/rfc822.py
MIT
def formatdate(timeval=None): """Returns time format preferred for Internet standards. Sun, 06 Nov 1994 08:49:37 GMT ; RFC 822, updated by RFC 1123 According to RFC 1123, day and month names must always be in English. If not for that, this code could use strftime(). It can't because strftime() honors the locale and could generate non-English names. """ if timeval is None: timeval = time.time() timeval = time.gmtime(timeval) return "%s, %02d %s %04d %02d:%02d:%02d GMT" % ( ("Mon", "Tue", "Wed", "Thu", "Fri", "Sat", "Sun")[timeval[6]], timeval[2], ("Jan", "Feb", "Mar", "Apr", "May", "Jun", "Jul", "Aug", "Sep", "Oct", "Nov", "Dec")[timeval[1]-1], timeval[0], timeval[3], timeval[4], timeval[5])
Returns time format preferred for Internet standards. Sun, 06 Nov 1994 08:49:37 GMT ; RFC 822, updated by RFC 1123 According to RFC 1123, day and month names must always be in English. If not for that, this code could use strftime(). It can't because strftime() honors the locale and could generate non-English names.
formatdate
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/rfc822.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/rfc822.py
MIT
def __init__(self, namespace = None): """Create a new completer for the command line. Completer([namespace]) -> completer instance. If unspecified, the default namespace where completions are performed is __main__ (technically, __main__.__dict__). Namespaces should be given as dictionaries. Completer instances should be used as the completion mechanism of readline via the set_completer() call: readline.set_completer(Completer(my_namespace).complete) """ if namespace and not isinstance(namespace, dict): raise TypeError,'namespace must be a dictionary' # Don't bind to namespace quite yet, but flag whether the user wants a # specific namespace or to use __main__.__dict__. This will allow us # to bind to __main__.__dict__ at completion time, not now. if namespace is None: self.use_main_ns = 1 else: self.use_main_ns = 0 self.namespace = namespace
Create a new completer for the command line. Completer([namespace]) -> completer instance. If unspecified, the default namespace where completions are performed is __main__ (technically, __main__.__dict__). Namespaces should be given as dictionaries. Completer instances should be used as the completion mechanism of readline via the set_completer() call: readline.set_completer(Completer(my_namespace).complete)
__init__
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/rlcompleter.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/rlcompleter.py
MIT
def complete(self, text, state): """Return the next possible completion for 'text'. This is called successively with state == 0, 1, 2, ... until it returns None. The completion should begin with 'text'. """ if self.use_main_ns: self.namespace = __main__.__dict__ if state == 0: if "." in text: self.matches = self.attr_matches(text) else: self.matches = self.global_matches(text) try: return self.matches[state] except IndexError: return None
Return the next possible completion for 'text'. This is called successively with state == 0, 1, 2, ... until it returns None. The completion should begin with 'text'.
complete
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/rlcompleter.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/rlcompleter.py
MIT
def global_matches(self, text): """Compute matches when text is a simple name. Return a list of all keywords, built-in functions and names currently defined in self.namespace that match. """ import keyword matches = [] seen = {"__builtins__"} n = len(text) for word in keyword.kwlist: if word[:n] == text: seen.add(word) matches.append(word) for nspace in [self.namespace, __builtin__.__dict__]: for word, val in nspace.items(): if word[:n] == text and word not in seen: seen.add(word) matches.append(self._callable_postfix(val, word)) return matches
Compute matches when text is a simple name. Return a list of all keywords, built-in functions and names currently defined in self.namespace that match.
global_matches
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/rlcompleter.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/rlcompleter.py
MIT
def attr_matches(self, text): """Compute matches when text contains a dot. Assuming the text is of the form NAME.NAME....[NAME], and is evaluable in self.namespace, it will be evaluated and its attributes (as revealed by dir()) are used as possible completions. (For class instances, class members are also considered.) WARNING: this can still invoke arbitrary C code, if an object with a __getattr__ hook is evaluated. """ import re m = re.match(r"(\w+(\.\w+)*)\.(\w*)", text) if not m: return [] expr, attr = m.group(1, 3) try: thisobject = eval(expr, self.namespace) except Exception: return [] # get the content of the object, except __builtins__ words = set(dir(thisobject)) words.discard("__builtins__") if hasattr(thisobject, '__class__'): words.add('__class__') words.update(get_class_members(thisobject.__class__)) matches = [] n = len(attr) for word in words: if word[:n] == attr: try: val = getattr(thisobject, word) except Exception: continue # Exclude properties that are not set word = self._callable_postfix(val, "%s.%s" % (expr, word)) matches.append(word) matches.sort() return matches
Compute matches when text contains a dot. Assuming the text is of the form NAME.NAME....[NAME], and is evaluable in self.namespace, it will be evaluated and its attributes (as revealed by dir()) are used as possible completions. (For class instances, class members are also considered.) WARNING: this can still invoke arbitrary C code, if an object with a __getattr__ hook is evaluated.
attr_matches
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/rlcompleter.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/rlcompleter.py
MIT
def modified(self): """Sets the time the robots.txt file was last fetched to the current time. """ import time self.last_checked = time.time()
Sets the time the robots.txt file was last fetched to the current time.
modified
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/robotparser.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/robotparser.py
MIT
def set_url(self, url): """Sets the URL referring to a robots.txt file.""" self.url = url self.host, self.path = urlparse.urlparse(url)[1:3]
Sets the URL referring to a robots.txt file.
set_url
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/robotparser.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/robotparser.py
MIT
def read(self): """Reads the robots.txt URL and feeds it to the parser.""" opener = URLopener() f = opener.open(self.url) lines = [line.strip() for line in f] f.close() self.errcode = opener.errcode if self.errcode in (401, 403): self.disallow_all = True elif self.errcode >= 400 and self.errcode < 500: self.allow_all = True elif self.errcode == 200 and lines: self.parse(lines)
Reads the robots.txt URL and feeds it to the parser.
read
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/robotparser.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/robotparser.py
MIT
def parse(self, lines): """parse the input lines from a robots.txt file. We allow that a user-agent: line is not preceded by one or more blank lines.""" # states: # 0: start state # 1: saw user-agent line # 2: saw an allow or disallow line state = 0 linenumber = 0 entry = Entry() self.modified() for line in lines: linenumber += 1 if not line: if state == 1: entry = Entry() state = 0 elif state == 2: self._add_entry(entry) entry = Entry() state = 0 # remove optional comment and strip line i = line.find('#') if i >= 0: line = line[:i] line = line.strip() if not line: continue line = line.split(':', 1) if len(line) == 2: line[0] = line[0].strip().lower() line[1] = urllib.unquote(line[1].strip()) if line[0] == "user-agent": if state == 2: self._add_entry(entry) entry = Entry() entry.useragents.append(line[1]) state = 1 elif line[0] == "disallow": if state != 0: entry.rulelines.append(RuleLine(line[1], False)) state = 2 elif line[0] == "allow": if state != 0: entry.rulelines.append(RuleLine(line[1], True)) state = 2 if state == 2: self._add_entry(entry)
parse the input lines from a robots.txt file. We allow that a user-agent: line is not preceded by one or more blank lines.
parse
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/robotparser.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/robotparser.py
MIT
def can_fetch(self, useragent, url): """using the parsed robots.txt decide if useragent can fetch url""" if self.disallow_all: return False if self.allow_all: return True # Until the robots.txt file has been read or found not # to exist, we must assume that no url is allowable. # This prevents false positives when a user erroneously # calls can_fetch() before calling read(). if not self.last_checked: return False # search for given user agent matches # the first match counts parsed_url = urlparse.urlparse(urllib.unquote(url)) url = urlparse.urlunparse(('', '', parsed_url.path, parsed_url.params, parsed_url.query, parsed_url.fragment)) url = urllib.quote(url) if not url: url = "/" for entry in self.entries: if entry.applies_to(useragent): return entry.allowance(url) # try the default entry last if self.default_entry: return self.default_entry.allowance(url) # agent not found ==> access granted return True
using the parsed robots.txt decide if useragent can fetch url
can_fetch
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/robotparser.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/robotparser.py
MIT
def applies_to(self, useragent): """check if this entry applies to the specified agent""" # split the name token and make it lower case useragent = useragent.split("/")[0].lower() for agent in self.useragents: if agent == '*': # we have the catch-all agent return True agent = agent.lower() if agent in useragent: return True return False
check if this entry applies to the specified agent
applies_to
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/robotparser.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/robotparser.py
MIT
def allowance(self, filename): """Preconditions: - our agent applies to this entry - filename is URL decoded""" for line in self.rulelines: if line.applies_to(filename): return line.allowance return True
Preconditions: - our agent applies to this entry - filename is URL decoded
allowance
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/robotparser.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/robotparser.py
MIT
def _run_code(code, run_globals, init_globals=None, mod_name=None, mod_fname=None, mod_loader=None, pkg_name=None): """Helper to run code in nominated namespace""" if init_globals is not None: run_globals.update(init_globals) run_globals.update(__name__ = mod_name, __file__ = mod_fname, __loader__ = mod_loader, __package__ = pkg_name) exec code in run_globals return run_globals
Helper to run code in nominated namespace
_run_code
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/runpy.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/runpy.py
MIT
def _run_module_code(code, init_globals=None, mod_name=None, mod_fname=None, mod_loader=None, pkg_name=None): """Helper to run code in new namespace with sys modified""" with _TempModule(mod_name) as temp_module, _ModifiedArgv0(mod_fname): mod_globals = temp_module.module.__dict__ _run_code(code, mod_globals, init_globals, mod_name, mod_fname, mod_loader, pkg_name) # Copy the globals of the temporary module, as they # may be cleared when the temporary module goes away return mod_globals.copy()
Helper to run code in new namespace with sys modified
_run_module_code
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/runpy.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/runpy.py
MIT
def _run_module_as_main(mod_name, alter_argv=True): """Runs the designated module in the __main__ namespace Note that the executed module will have full access to the __main__ namespace. If this is not desirable, the run_module() function should be used to run the module code in a fresh namespace. At the very least, these variables in __main__ will be overwritten: __name__ __file__ __loader__ __package__ """ try: if alter_argv or mod_name != "__main__": # i.e. -m switch mod_name, loader, code, fname = _get_module_details( mod_name, _Error) else: # i.e. directory or zipfile execution mod_name, loader, code, fname = _get_main_module_details(_Error) except _Error as exc: msg = "%s: %s" % (sys.executable, exc) sys.exit(msg) pkg_name = mod_name.rpartition('.')[0] main_globals = sys.modules["__main__"].__dict__ if alter_argv: sys.argv[0] = fname return _run_code(code, main_globals, None, "__main__", fname, loader, pkg_name)
Runs the designated module in the __main__ namespace Note that the executed module will have full access to the __main__ namespace. If this is not desirable, the run_module() function should be used to run the module code in a fresh namespace. At the very least, these variables in __main__ will be overwritten: __name__ __file__ __loader__ __package__
_run_module_as_main
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/runpy.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/runpy.py
MIT
def run_module(mod_name, init_globals=None, run_name=None, alter_sys=False): """Execute a module's code without importing it Returns the resulting top level namespace dictionary """ mod_name, loader, code, fname = _get_module_details(mod_name) if run_name is None: run_name = mod_name pkg_name = mod_name.rpartition('.')[0] if alter_sys: return _run_module_code(code, init_globals, run_name, fname, loader, pkg_name) else: # Leave the sys module alone return _run_code(code, {}, init_globals, run_name, fname, loader, pkg_name)
Execute a module's code without importing it Returns the resulting top level namespace dictionary
run_module
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/runpy.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/runpy.py
MIT
def run_path(path_name, init_globals=None, run_name=None): """Execute code located at the specified filesystem location Returns the resulting top level namespace dictionary The file path may refer directly to a Python script (i.e. one that could be directly executed with execfile) or else it may refer to a zipfile or directory containing a top level __main__.py script. """ if run_name is None: run_name = "<run_path>" importer = _get_importer(path_name) if isinstance(importer, imp.NullImporter): # Not a valid sys.path entry, so run the code directly # execfile() doesn't help as we want to allow compiled files code = _get_code_from_file(path_name) return _run_module_code(code, init_globals, run_name, path_name) else: # Importer is defined for path, so add it to # the start of sys.path sys.path.insert(0, path_name) try: # Here's where things are a little different from the run_module # case. There, we only had to replace the module in sys while the # code was running and doing so was somewhat optional. Here, we # have no choice and we have to remove it even while we read the # code. If we don't do this, a __loader__ attribute in the # existing __main__ module may prevent location of the new module. main_name = "__main__" saved_main = sys.modules[main_name] del sys.modules[main_name] try: mod_name, loader, code, fname = _get_main_module_details() finally: sys.modules[main_name] = saved_main pkg_name = "" with _TempModule(run_name) as temp_module, \ _ModifiedArgv0(path_name): mod_globals = temp_module.module.__dict__ return _run_code(code, mod_globals, init_globals, run_name, fname, loader, pkg_name).copy() finally: try: sys.path.remove(path_name) except ValueError: pass
Execute code located at the specified filesystem location Returns the resulting top level namespace dictionary The file path may refer directly to a Python script (i.e. one that could be directly executed with execfile) or else it may refer to a zipfile or directory containing a top level __main__.py script.
run_path
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/runpy.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/runpy.py
MIT
def __init__(self, timefunc, delayfunc): """Initialize a new instance, passing the time and delay functions""" self._queue = [] self.timefunc = timefunc self.delayfunc = delayfunc
Initialize a new instance, passing the time and delay functions
__init__
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/sched.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/sched.py
MIT
def enterabs(self, time, priority, action, argument): """Enter a new event in the queue at an absolute time. Returns an ID for the event which can be used to remove it, if necessary. """ event = Event(time, priority, action, argument) heapq.heappush(self._queue, event) return event # The ID
Enter a new event in the queue at an absolute time. Returns an ID for the event which can be used to remove it, if necessary.
enterabs
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/sched.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/sched.py
MIT
def enter(self, delay, priority, action, argument): """A variant that specifies the time as a relative time. This is actually the more commonly used interface. """ time = self.timefunc() + delay return self.enterabs(time, priority, action, argument)
A variant that specifies the time as a relative time. This is actually the more commonly used interface.
enter
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/sched.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/sched.py
MIT
def run(self): """Execute events until the queue is empty. When there is a positive delay until the first event, the delay function is called and the event is left in the queue; otherwise, the event is removed from the queue and executed (its action function is called, passing it the argument). If the delay function returns prematurely, it is simply restarted. It is legal for both the delay function and the action function to modify the queue or to raise an exception; exceptions are not caught but the scheduler's state remains well-defined so run() may be called again. A questionable hack is added to allow other threads to run: just after an event is executed, a delay of 0 is executed, to avoid monopolizing the CPU when other threads are also runnable. """ # localize variable access to minimize overhead # and to improve thread safety q = self._queue delayfunc = self.delayfunc timefunc = self.timefunc pop = heapq.heappop while q: time, priority, action, argument = checked_event = q[0] now = timefunc() if now < time: delayfunc(time - now) else: event = pop(q) # Verify that the event was not removed or altered # by another thread after we last looked at q[0]. if event is checked_event: action(*argument) delayfunc(0) # Let other threads run else: heapq.heappush(q, event)
Execute events until the queue is empty. When there is a positive delay until the first event, the delay function is called and the event is left in the queue; otherwise, the event is removed from the queue and executed (its action function is called, passing it the argument). If the delay function returns prematurely, it is simply restarted. It is legal for both the delay function and the action function to modify the queue or to raise an exception; exceptions are not caught but the scheduler's state remains well-defined so run() may be called again. A questionable hack is added to allow other threads to run: just after an event is executed, a delay of 0 is executed, to avoid monopolizing the CPU when other threads are also runnable.
run
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/sched.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/sched.py
MIT
def queue(self): """An ordered list of upcoming events. Events are named tuples with fields for: time, priority, action, arguments """ # Use heapq to sort the queue rather than using 'sorted(self._queue)'. # With heapq, two events scheduled at the same time will show in # the actual order they would be retrieved. events = self._queue[:] return map(heapq.heappop, [events]*len(events))
An ordered list of upcoming events. Events are named tuples with fields for: time, priority, action, arguments
queue
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/sched.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/sched.py
MIT
def __deepcopy__(self, memo): """Return a deep copy of a set; used by copy module.""" # This pre-creates the result and inserts it in the memo # early, in case the deep copy recurses into another reference # to this same set. A set can't be an element of itself, but # it can certainly contain an object that has a reference to # itself. from copy import deepcopy result = self.__class__() memo[id(self)] = result data = result._data value = True for elt in self: data[deepcopy(elt, memo)] = value return result
Return a deep copy of a set; used by copy module.
__deepcopy__
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/sets.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/sets.py
MIT
def __or__(self, other): """Return the union of two sets as a new set. (I.e. all elements that are in either set.) """ if not isinstance(other, BaseSet): return NotImplemented return self.union(other)
Return the union of two sets as a new set. (I.e. all elements that are in either set.)
__or__
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/sets.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/sets.py
MIT
def union(self, other): """Return the union of two sets as a new set. (I.e. all elements that are in either set.) """ result = self.__class__(self) result._update(other) return result
Return the union of two sets as a new set. (I.e. all elements that are in either set.)
union
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/sets.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/sets.py
MIT
def __and__(self, other): """Return the intersection of two sets as a new set. (I.e. all elements that are in both sets.) """ if not isinstance(other, BaseSet): return NotImplemented return self.intersection(other)
Return the intersection of two sets as a new set. (I.e. all elements that are in both sets.)
__and__
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/sets.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/sets.py
MIT
def intersection(self, other): """Return the intersection of two sets as a new set. (I.e. all elements that are in both sets.) """ if not isinstance(other, BaseSet): other = Set(other) if len(self) <= len(other): little, big = self, other else: little, big = other, self common = ifilter(big._data.__contains__, little) return self.__class__(common)
Return the intersection of two sets as a new set. (I.e. all elements that are in both sets.)
intersection
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/sets.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/sets.py
MIT
def __xor__(self, other): """Return the symmetric difference of two sets as a new set. (I.e. all elements that are in exactly one of the sets.) """ if not isinstance(other, BaseSet): return NotImplemented return self.symmetric_difference(other)
Return the symmetric difference of two sets as a new set. (I.e. all elements that are in exactly one of the sets.)
__xor__
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/sets.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/sets.py
MIT
def symmetric_difference(self, other): """Return the symmetric difference of two sets as a new set. (I.e. all elements that are in exactly one of the sets.) """ result = self.__class__() data = result._data value = True selfdata = self._data try: otherdata = other._data except AttributeError: otherdata = Set(other)._data for elt in ifilterfalse(otherdata.__contains__, selfdata): data[elt] = value for elt in ifilterfalse(selfdata.__contains__, otherdata): data[elt] = value return result
Return the symmetric difference of two sets as a new set. (I.e. all elements that are in exactly one of the sets.)
symmetric_difference
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/sets.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/sets.py
MIT
def __sub__(self, other): """Return the difference of two sets as a new Set. (I.e. all elements that are in this set and not in the other.) """ if not isinstance(other, BaseSet): return NotImplemented return self.difference(other)
Return the difference of two sets as a new Set. (I.e. all elements that are in this set and not in the other.)
__sub__
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/sets.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/sets.py
MIT
def difference(self, other): """Return the difference of two sets as a new Set. (I.e. all elements that are in this set and not in the other.) """ result = self.__class__() data = result._data try: otherdata = other._data except AttributeError: otherdata = Set(other)._data value = True for elt in ifilterfalse(otherdata.__contains__, self): data[elt] = value return result
Return the difference of two sets as a new Set. (I.e. all elements that are in this set and not in the other.)
difference
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/sets.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/sets.py
MIT
def __contains__(self, element): """Report whether an element is a member of a set. (Called in response to the expression `element in self'.) """ try: return element in self._data except TypeError: transform = getattr(element, "__as_temporarily_immutable__", None) if transform is None: raise # re-raise the TypeError exception we caught return transform() in self._data
Report whether an element is a member of a set. (Called in response to the expression `element in self'.)
__contains__
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/sets.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/sets.py
MIT
def issubset(self, other): """Report whether another set contains this set.""" self._binary_sanity_check(other) if len(self) > len(other): # Fast check for obvious cases return False for elt in ifilterfalse(other._data.__contains__, self): return False return True
Report whether another set contains this set.
issubset
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/sets.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/sets.py
MIT
def issuperset(self, other): """Report whether this set contains another set.""" self._binary_sanity_check(other) if len(self) < len(other): # Fast check for obvious cases return False for elt in ifilterfalse(self._data.__contains__, other): return False return True
Report whether this set contains another set.
issuperset
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/sets.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/sets.py
MIT
def __init__(self, iterable=None): """Construct an immutable set from an optional iterable.""" self._hashcode = None self._data = {} if iterable is not None: self._update(iterable)
Construct an immutable set from an optional iterable.
__init__
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/sets.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/sets.py
MIT
def __init__(self, iterable=None): """Construct a set from an optional iterable.""" self._data = {} if iterable is not None: self._update(iterable)
Construct a set from an optional iterable.
__init__
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/sets.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/sets.py
MIT
def __ior__(self, other): """Update a set with the union of itself and another.""" self._binary_sanity_check(other) self._data.update(other._data) return self
Update a set with the union of itself and another.
__ior__
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/sets.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/sets.py
MIT
def __iand__(self, other): """Update a set with the intersection of itself and another.""" self._binary_sanity_check(other) self._data = (self & other)._data return self
Update a set with the intersection of itself and another.
__iand__
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/sets.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/sets.py
MIT
def intersection_update(self, other): """Update a set with the intersection of itself and another.""" if isinstance(other, BaseSet): self &= other else: self._data = (self.intersection(other))._data
Update a set with the intersection of itself and another.
intersection_update
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/sets.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/sets.py
MIT
def __ixor__(self, other): """Update a set with the symmetric difference of itself and another.""" self._binary_sanity_check(other) self.symmetric_difference_update(other) return self
Update a set with the symmetric difference of itself and another.
__ixor__
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/sets.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/sets.py
MIT
def symmetric_difference_update(self, other): """Update a set with the symmetric difference of itself and another.""" data = self._data value = True if not isinstance(other, BaseSet): other = Set(other) if self is other: self.clear() for elt in other: if elt in data: del data[elt] else: data[elt] = value
Update a set with the symmetric difference of itself and another.
symmetric_difference_update
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/sets.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/sets.py
MIT
def __isub__(self, other): """Remove all elements of another set from this set.""" self._binary_sanity_check(other) self.difference_update(other) return self
Remove all elements of another set from this set.
__isub__
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/sets.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/sets.py
MIT
def difference_update(self, other): """Remove all elements of another set from this set.""" data = self._data if not isinstance(other, BaseSet): other = Set(other) if self is other: self.clear() for elt in ifilter(data.__contains__, other): del data[elt]
Remove all elements of another set from this set.
difference_update
python
mchristopher/PokemonGo-DesktopMap
app/pywin/Lib/sets.py
https://github.com/mchristopher/PokemonGo-DesktopMap/blob/master/app/pywin/Lib/sets.py
MIT