Set operations for arrays based on sorting.
For floating point arrays, inaccurate results may appear due to usual round-off and floating point comparison issues.
Speed could be gained in some operations by an implementation of
numpy.sort
, that can provide directly the permutation vectors, thus avoiding
calls to numpy.argsort
.
Original author: Robert Cimrman
Variable | array_function_dispatch |
Undocumented |
Function | _ediff1d_dispatcher |
Undocumented |
Function | _in1d_dispatcher |
Undocumented |
Function | _intersect1d_dispatcher |
Undocumented |
Function | _isin_dispatcher |
Undocumented |
Function | _setdiff1d_dispatcher |
Undocumented |
Function | _setxor1d_dispatcher |
Undocumented |
Function | _union1d_dispatcher |
Undocumented |
Function | _unique1d |
Find the unique elements of an array, ignoring shape. |
Function | _unique_dispatcher |
Undocumented |
Function | _unpack_tuple |
Unpacks one-element tuples for use as return values |
Function | ediff1d |
The differences between consecutive elements of an array. |
Function | in1d |
Test whether each element of a 1-D array is also present in a second array. |
Function | intersect1d |
Find the intersection of two arrays. |
Function | isin |
Calculates element in test_elements , broadcasting over element only. Returns a boolean array of the same shape as element that is True where an element of element is in test_elements and False otherwise. |
Function | setdiff1d |
Find the set difference of two arrays. |
Function | setxor1d |
Find the set exclusive-or of two arrays. |
Function | union1d |
Find the union of two arrays. |
Function | unique |
Find the unique elements of an array. |
Undocumented
The differences between consecutive elements of an array.
diff, gradient
When applied to masked arrays, this function drops the mask information
if the to_begin
and/or to_end
parameters are used.
>>> x = np.array([1, 2, 4, 7, 0]) >>> np.ediff1d(x) array([ 1, 2, 3, -7])
>>> np.ediff1d(x, to_begin=-99, to_end=np.array([88, 99])) array([-99, 1, 2, ..., -7, 88, 99])
The returned array is always 1D.
>>> y = [[1, 2, 4], [1, 6, 24]] >>> np.ediff1d(y) array([ 1, 2, -3, 5, 18])
Test whether each element of a 1-D array is also present in a second array.
Returns a boolean array the same length as ar1
that is True
where an element of ar1
is in ar2
and False otherwise.
We recommend using isin
instead of in1d
for new code.
ar1
.If True, the values in the returned array are inverted (that is,
False where an element of ar1
is in ar2
and True otherwise).
Default is False. np.in1d(a, b, invert=True) is equivalent
to (but is faster than) np.invert(in1d(a, b)).
ar1[in1d]
are in ar2
.in1d
can be considered as an element-wise function version of the
python keyword in
, for 1-D sequences. in1d(a, b) is roughly
equivalent to np.array([item in b for item in a]).
However, this idea fails if ar2
is a set, or similar (non-sequence)
container: As ar2 is converted to an array, in those cases
asarray(ar2) is an object array rather than the expected array of
contained values.
>>> test = np.array([0, 1, 2, 5, 0]) >>> states = [0, 2] >>> mask = np.in1d(test, states) >>> mask array([ True, False, True, False, True]) >>> test[mask] array([0, 2, 0]) >>> mask = np.in1d(test, states, invert=True) >>> mask array([False, True, False, True, False]) >>> test[mask] array([1, 5])
Find the intersection of two arrays.
Return the sorted, unique values that are in both of the input arrays.
If True, the indices which correspond to the intersection of the two arrays are returned. The first instance of a value is used if there are multiple. Default is False.
ar1
.
Only provided if return_indices
is True.ar2
.
Only provided if return_indices
is True.>>> np.intersect1d([1, 3, 4, 3], [3, 1, 2, 1]) array([1, 3])
To intersect more than two arrays, use functools.reduce:
>>> from functools import reduce >>> reduce(np.intersect1d, ([1, 3, 4, 3], [3, 1, 2, 1], [6, 3, 4, 2])) array([3])
To return the indices of the values common to the input arrays along with the intersected values:
>>> x = np.array([1, 1, 2, 3, 4]) >>> y = np.array([2, 1, 4, 6]) >>> xy, x_ind, y_ind = np.intersect1d(x, y, return_indices=True) >>> x_ind, y_ind (array([0, 2, 4]), array([1, 0, 2])) >>> xy, x[x_ind], y[y_ind] (array([1, 2, 4]), array([1, 2, 4]), array([1, 2, 4]))
Calculates element in test_elements
, broadcasting over element
only.
Returns a boolean array of the same shape as element
that is True
where an element of element
is in test_elements
and False otherwise.
element
.
This argument is flattened if it is an array or array_like.
See notes for behavior with non-array-like parameters.element not in test_elements
. Default is False.
np.isin(a, b, invert=True) is equivalent to (but faster
than) np.invert(np.isin(a, b)).element
. The values element[isin]
are in test_elements
.in1d : Flattened version of this function. numpy.lib.arraysetops : Module with a number of other functions for
performing set operations on arrays.
isin
is an element-wise function version of the python keyword in
.
isin(a, b) is roughly equivalent to
np.array([item in b for item in a]) if a
and b
are 1-D sequences.
element
and test_elements
are converted to arrays if they are not
already. If test_elements
is a set (or other non-sequence collection)
it will be converted to an object array with one element, rather than an
array of the values contained in test_elements
. This is a consequence
of the array
constructor's way of handling non-sequence collections.
Converting the set to a list usually gives the desired behavior.
>>> element = 2*np.arange(4).reshape((2, 2)) >>> element array([[0, 2], [4, 6]]) >>> test_elements = [1, 2, 4, 8] >>> mask = np.isin(element, test_elements) >>> mask array([[False, True], [ True, False]]) >>> element[mask] array([2, 4])
The indices of the matched values can be obtained with nonzero
:
>>> np.nonzero(mask) (array([0, 1]), array([1, 0]))
The test can also be inverted:
>>> mask = np.isin(element, test_elements, invert=True) >>> mask array([[ True, False], [False, True]]) >>> element[mask] array([0, 6])
Because of how array
handles sets, the following does not
work as expected:
>>> test_set = {1, 2, 4, 8} >>> np.isin(element, test_set) array([[False, False], [False, False]])
Casting the set to a list gives the expected result:
>>> np.isin(element, list(test_set)) array([[False, True], [ True, False]])
Find the set difference of two arrays.
Return the unique values in ar1
that are not in ar2
.
ar1
that are not in ar2
. The result
is sorted when assume_unique=False
, but otherwise only sorted
if the input is sorted.>>> a = np.array([1, 2, 3, 2, 4, 1]) >>> b = np.array([3, 4, 5, 6]) >>> np.setdiff1d(a, b) array([1, 2])
Find the set exclusive-or of two arrays.
Return the sorted, unique values that are in only one (not both) of the input arrays.
>>> a = np.array([1, 2, 3, 2, 4]) >>> b = np.array([2, 3, 5, 7, 5]) >>> np.setxor1d(a,b) array([1, 4, 5, 7])
Find the union of two arrays.
Return the unique, sorted array of values that are in either of the two input arrays.
>>> np.union1d([-1, 0, 1], [-2, 0, 2]) array([-2, -1, 0, 1, 2])
To find the union of more than two arrays, use functools.reduce:
>>> from functools import reduce >>> reduce(np.union1d, ([1, 3, 4, 3], [3, 1, 2, 1], [6, 3, 4, 2])) array([1, 2, 3, 4, 6])
Find the unique elements of an array.
Returns the sorted unique elements of an array. There are three optional outputs in addition to the unique elements:
axis
is specified, this will be flattened if it
is not already 1-D.ar
(along the specified axis,
if provided, or in the flattened array) that result in the unique array.ar
.If True, also return the number of times each unique item appears
in ar
.
The axis to operate on. If None, ar
will be flattened. If an integer,
the subarrays indexed by the given axis will be flattened and treated
as the elements of a 1-D array with the dimension of the given axis,
see the notes for more details. Object arrays or structured arrays
that contain objects are not supported if the axis
kwarg is used. The
default is None.
return_index
is True.return_inverse
is True.The number of times each of the unique values comes up in the
original array. Only provided if return_counts
is True.
repeat : Repeat elements of an array.
When an axis is specified the subarrays indexed by the axis are sorted. This is done by making the specified axis the first dimension of the array (move the axis to the first dimension to keep the order of the other axes) and then flattening the subarrays in C order. The flattened subarrays are then viewed as a structured type with each element given a label, with the effect that we end up with a 1-D array of structured types that can be treated in the same way as any other 1-D array. The result is that the flattened subarrays are sorted in lexicographic order starting with the first element.
>>> np.unique([1, 1, 2, 2, 3, 3]) array([1, 2, 3]) >>> a = np.array([[1, 1], [2, 3]]) >>> np.unique(a) array([1, 2, 3])
Return the unique rows of a 2D array
>>> a = np.array([[1, 0, 0], [1, 0, 0], [2, 3, 4]]) >>> np.unique(a, axis=0) array([[1, 0, 0], [2, 3, 4]])
Return the indices of the original array that give the unique values:
>>> a = np.array(['a', 'b', 'b', 'c', 'a']) >>> u, indices = np.unique(a, return_index=True) >>> u array(['a', 'b', 'c'], dtype='<U1') >>> indices array([0, 1, 3]) >>> a[indices] array(['a', 'b', 'c'], dtype='<U1')
Reconstruct the input array from the unique values and inverse:
>>> a = np.array([1, 2, 6, 4, 2, 3, 2]) >>> u, indices = np.unique(a, return_inverse=True) >>> u array([1, 2, 3, 4, 6]) >>> indices array([0, 1, 4, 3, 1, 2, 1]) >>> u[indices] array([1, 2, 6, 4, 2, 3, 2])
Reconstruct the input values from the unique values and counts:
>>> a = np.array([1, 2, 6, 4, 2, 3, 2]) >>> values, counts = np.unique(a, return_counts=True) >>> values array([1, 2, 3, 4, 6]) >>> counts array([1, 3, 1, 1, 1]) >>> np.repeat(values, counts) array([1, 2, 2, 2, 3, 4, 6]) # original order not preserved