Skip to content

Commit

Permalink
fix: EOF everywhere
Browse files Browse the repository at this point in the history
  • Loading branch information
convert-repo authored and neutrinoceros committed Jan 1, 2021
1 parent 8f0508b commit 5e5ce14
Show file tree
Hide file tree
Showing 68 changed files with 15 additions and 79 deletions.
2 changes: 1 addition & 1 deletion .git-blame-ignore-revs
Original file line number Diff line number Diff line change
Expand Up @@ -25,4 +25,4 @@ cae222aec845d0b400e2aa2804e75b2adef17ccd
993162d6fb38f55b0bf372da1c3b984ee2d4f085
ef783151bfd7c6777fa25e9e06f95fe47653b3aa
063e2fb630932cbdcbbbdba603c100a37e7e40f6
279b0551ccc9d9d4c114904b94bc705381c61105
279b0551ccc9d9d4c114904b94bc705381c61105
1 change: 0 additions & 1 deletion .github/ISSUE_TEMPLATE.md
Original file line number Diff line number Diff line change
Expand Up @@ -54,4 +54,3 @@ using:-->
<!--Please tell us how you installed yt and python e.g., from source,
pip, conda. If you installed from conda, please specify which channel you used
if not the default-->

2 changes: 1 addition & 1 deletion .hgchurn
Original file line number Diff line number Diff line change
Expand Up @@ -56,4 +56,4 @@ [email protected] = [email protected]
Fabian Koller = [email protected]
Rafael Ruggiero = [email protected]
[email protected] = [email protected]
[email protected] = [email protected]
[email protected] = [email protected]
2 changes: 0 additions & 2 deletions README.md
Original file line number Diff line number Diff line change
Expand Up @@ -165,5 +165,3 @@ yt is a fiscally sponsored project of [NumFOCUS](https://numfocus.org/).
If you're interested in
supporting the active maintenance and development of this project, consider
[donating to the project](https://numfocus.salsalabs.org/donate-to-yt/index.html).


1 change: 0 additions & 1 deletion benchmarks/benchmarks/__init__.py
Original file line number Diff line number Diff line change
@@ -1 +0,0 @@

1 change: 0 additions & 1 deletion doc/activate.csh
Original file line number Diff line number Diff line change
Expand Up @@ -52,4 +52,3 @@ set prompt = "[$env_name] $prompt"
unset env_name

rehash

1 change: 0 additions & 1 deletion doc/source/analyzing/_static/axes.h
Original file line number Diff line number Diff line change
Expand Up @@ -7,4 +7,3 @@ typedef struct structParticleCollection {

void calculate_axes(ParticleCollection *part,
double *ax1, double *ax2, double *ax3);

1 change: 0 additions & 1 deletion doc/source/analyzing/_static/axes_calculator_setup.txt
Original file line number Diff line number Diff line change
Expand Up @@ -22,4 +22,3 @@ setup(
cmdclass = {'build_ext': build_ext},
ext_modules = ext_modules
)

1 change: 0 additions & 1 deletion doc/source/analyzing/domain_analysis/xray_data_README.rst
Original file line number Diff line number Diff line change
Expand Up @@ -65,4 +65,3 @@ Other Useful Things Not Included Here

Simulates a photon-counting detector's response to an input source,
including a simplified models of telescopes.

1 change: 0 additions & 1 deletion doc/source/analyzing/units.rst
Original file line number Diff line number Diff line change
Expand Up @@ -332,4 +332,3 @@ second example returns data in low-redshift comoving megaparsecs.
Wherever possible it's best to do calculations in physical units when working
with more than one dataset. If you need to use comoving units or code units then
extra care must be taken in your code to avoid ambiguity.

2 changes: 1 addition & 1 deletion doc/source/cookbook/fits_radio_cubes.rst
Original file line number Diff line number Diff line change
Expand Up @@ -3,4 +3,4 @@
FITS Radio Cubes in yt
----------------------

.. notebook:: fits_radio_cubes.ipynb
.. notebook:: fits_radio_cubes.ipynb
1 change: 0 additions & 1 deletion doc/source/cookbook/gadget_notebook.rst
Original file line number Diff line number Diff line change
Expand Up @@ -4,4 +4,3 @@ Using yt to view and analyze Gadget outputs
++++++++++++++++++++++++++++++++++++++++++++++++++++++++

.. notebook:: yt_gadget_analysis.ipynb

Original file line number Diff line number Diff line change
Expand Up @@ -485,4 +485,4 @@
},
"nbformat": 4,
"nbformat_minor": 2
}
}
1 change: 0 additions & 1 deletion doc/source/cookbook/owls_notebook.rst
Original file line number Diff line number Diff line change
Expand Up @@ -4,4 +4,3 @@ Using yt to view and analyze Gadget-OWLS outputs
++++++++++++++++++++++++++++++++++++++++++++++++

.. notebook:: yt_gadget_owls_analysis.ipynb

1 change: 0 additions & 1 deletion doc/source/cookbook/tipsy_notebook.rst
Original file line number Diff line number Diff line change
Expand Up @@ -4,4 +4,3 @@ Using yt to view and analyze Tipsy outputs from Gasoline
++++++++++++++++++++++++++++++++++++++++++++++++++++++++

.. notebook:: tipsy_and_yt.ipynb

2 changes: 1 addition & 1 deletion doc/source/cookbook/yt_gadget_analysis.ipynb
Original file line number Diff line number Diff line change
Expand Up @@ -269,4 +269,4 @@
},
"nbformat": 4,
"nbformat_minor": 0
}
}
1 change: 0 additions & 1 deletion doc/source/developing/releasing.rst
Original file line number Diff line number Diff line change
Expand Up @@ -237,4 +237,3 @@ After the release is uploaded to `PyPI <https://pypi.org/project/yt/#files>`_ an
you should send out an announcement
e-mail to the yt mailing lists as well as other possibly interested mailing
lists for all but bugfix releases.

1 change: 0 additions & 1 deletion doc/source/visualizing/_images/scene_diagram.svg
Loading
Sorry, something went wrong. Reload?
Sorry, we cannot display this file.
Sorry, this file is invalid so it cannot be displayed.
2 changes: 1 addition & 1 deletion doc/source/visualizing/writing_fits_images.rst
Original file line number Diff line number Diff line change
Expand Up @@ -3,4 +3,4 @@
Writing FITS Images
==========================

.. notebook:: FITSImageData.ipynb
.. notebook:: FITSImageData.ipynb
2 changes: 1 addition & 1 deletion pyproject.toml
Original file line number Diff line number Diff line change
Expand Up @@ -56,4 +56,4 @@ known_third_party = [
"glue",
]
known_first_party = ["yt"]
sections = ["FUTURE", "STDLIB", "THIRDPARTY", "FIRSTPARTY", "LOCALFOLDER"]
sections = ["FUTURE", "STDLIB", "THIRDPARTY", "FIRSTPARTY", "LOCALFOLDER"]
1 change: 0 additions & 1 deletion tests/DD0000/moving7_0000
Original file line number Diff line number Diff line change
Expand Up @@ -209,4 +209,3 @@ CosmologyFinalRedshift = 0.3
CosmologyCurrentRedshift = 10

VersionNumber = 1.300000

1 change: 0 additions & 1 deletion tests/DD0010/moving7_0010
Original file line number Diff line number Diff line change
Expand Up @@ -214,4 +214,3 @@ CosmologyFinalRedshift = 0.3
CosmologyCurrentRedshift = 9.9910277956689

VersionNumber = 1.300000

2 changes: 1 addition & 1 deletion tests/README
Original file line number Diff line number Diff line change
@@ -1,3 +1,3 @@
This directory contains two tiny enzo cosmological datasets.

They were added a long time ago and are provided for testing purposes.
They were added a long time ago and are provided for testing purposes.
1 change: 0 additions & 1 deletion yt/frontends/artio/_artio_caller.pyx
Original file line number Diff line number Diff line change
Expand Up @@ -1705,4 +1705,3 @@ cdef class SFCRangeSelector(SelectorObject):

sfc_subset_selector = AlwaysSelector
#sfc_subset_selector = SFCRangeSelector

1 change: 0 additions & 1 deletion yt/geometry/_selection_routines/always_selector.pxi
Original file line number Diff line number Diff line change
Expand Up @@ -43,4 +43,3 @@ cdef class AlwaysSelector(SelectorObject):
return ("always", 1,)

always_selector = AlwaysSelector

1 change: 0 additions & 1 deletion yt/geometry/_selection_routines/compose_selector.pxi
Original file line number Diff line number Diff line change
Expand Up @@ -66,4 +66,3 @@ cdef class ComposeSelector(SelectorObject):
return (hash(self.selector1), hash(self.selector2))

compose_selector = ComposeSelector

1 change: 0 additions & 1 deletion yt/geometry/_selection_routines/cut_region_selector.pxi
Original file line number Diff line number Diff line change
Expand Up @@ -38,4 +38,3 @@ cdef class CutRegionSelector(SelectorObject):
return ("conditionals", t)

cut_region_selector = CutRegionSelector

1 change: 0 additions & 1 deletion yt/geometry/_selection_routines/cutting_plane_selector.pxi
Original file line number Diff line number Diff line change
Expand Up @@ -115,4 +115,3 @@ cdef class CuttingPlaneSelector(SelectorObject):
return ("d", "norm_vec")

cutting_selector = CuttingPlaneSelector

1 change: 0 additions & 1 deletion yt/geometry/_selection_routines/disk_selector.pxi
Original file line number Diff line number Diff line change
Expand Up @@ -166,4 +166,3 @@ cdef class DiskSelector(SelectorObject):


disk_selector = DiskSelector

1 change: 0 additions & 1 deletion yt/geometry/_selection_routines/ellipsoid_selector.pxi
Original file line number Diff line number Diff line change
Expand Up @@ -146,4 +146,3 @@ cdef class EllipsoidSelector(SelectorObject):


ellipsoid_selector = EllipsoidSelector

1 change: 0 additions & 1 deletion yt/geometry/_selection_routines/grid_selector.pxi
Original file line number Diff line number Diff line change
Expand Up @@ -36,4 +36,3 @@ cdef class GridSelector(SelectorObject):
return (self.ind,)

grid_selector = GridSelector

Original file line number Diff line number Diff line change
Expand Up @@ -12,4 +12,3 @@ cdef class HaloParticlesSelector(SelectorObject):
return ("halo_particles", self.halo_id)

halo_particles_selector = HaloParticlesSelector

Original file line number Diff line number Diff line change
Expand Up @@ -71,4 +71,3 @@ cdef class IndexedOctreeSubsetSelector(SelectorObject):
return (hash(self.base_selector), self.min_ind, self.max_ind)

indexed_octree_subset_selector = IndexedOctreeSubsetSelector

1 change: 0 additions & 1 deletion yt/geometry/_selection_routines/octree_subset_selector.pxi
Original file line number Diff line number Diff line change
Expand Up @@ -62,4 +62,3 @@ cdef class OctreeSubsetSelector(SelectorObject):
return (hash(self.base_selector), self.domain_id)

octree_subset_selector = OctreeSubsetSelector

1 change: 0 additions & 1 deletion yt/geometry/_selection_routines/ortho_ray_selector.pxi
Original file line number Diff line number Diff line change
Expand Up @@ -114,4 +114,3 @@ cdef class OrthoRaySelector(SelectorObject):
return ("px_ax", "py_ax", "px", "py", "axis")

ortho_ray_selector = OrthoRaySelector

2 changes: 0 additions & 2 deletions yt/geometry/_selection_routines/point_selector.pxi
Original file line number Diff line number Diff line change
Expand Up @@ -75,5 +75,3 @@ cdef class PointSelector(SelectorObject):
return ('p', )

point_selector = PointSelector


1 change: 0 additions & 1 deletion yt/geometry/_selection_routines/ray_selector.pxi
Original file line number Diff line number Diff line change
Expand Up @@ -287,4 +287,3 @@ cdef class RaySelector(SelectorObject):
return ("p1", "p2", "vec")

ray_selector = RaySelector

1 change: 0 additions & 1 deletion yt/geometry/_selection_routines/region_selector.pxi
Original file line number Diff line number Diff line change
Expand Up @@ -209,4 +209,3 @@ cdef class RegionSelector(SelectorObject):
'is_all_data', 'loose_selection')

region_selector = RegionSelector

1 change: 0 additions & 1 deletion yt/geometry/_selection_routines/selector_object.pxi
Original file line number Diff line number Diff line change
Expand Up @@ -604,4 +604,3 @@ cdef class SelectorObject:
# parse and set attributes from the state_tuple: (('a1',a1val),('a2',a2val),...)
for attr in state_tuple:
setattr(self, attr[0], attr[1])

1 change: 0 additions & 1 deletion yt/geometry/_selection_routines/sphere_selector.pxi
Original file line number Diff line number Diff line change
Expand Up @@ -171,4 +171,3 @@ cdef class SphereSelector(SelectorObject):


sphere_selector = SphereSelector

2 changes: 1 addition & 1 deletion yt/geometry/grid_container.pxd
Original file line number Diff line number Diff line change
Expand Up @@ -64,4 +64,4 @@ cdef class MatchPointsToGrids:
GridTreeNode *grid)

cdef extern from "platform_dep.h" nogil:
double rint(double x)
double rint(double x)
1 change: 0 additions & 1 deletion yt/geometry/grid_container.pyx
Original file line number Diff line number Diff line change
Expand Up @@ -352,4 +352,3 @@ cdef class MatchPointsToGrids:
if y < grid.left_edge[1]: return 0
if z < grid.left_edge[2]: return 0
return 1

1 change: 0 additions & 1 deletion yt/geometry/oct_visitors.pxd
Original file line number Diff line number Diff line change
Expand Up @@ -175,4 +175,3 @@ cdef class NeighbourCellVisitor(BaseNeighbourVisitor):
cdef np.int64_t[::1] file_inds
cdef np.uint8_t[::1] cell_inds
cdef np.int32_t[::1] domains

2 changes: 1 addition & 1 deletion yt/sample_data_registry.json
Original file line number Diff line number Diff line change
Expand Up @@ -858,4 +858,4 @@
"load_name": "ytdata_test/slice.h5",
"url": "https://yt-project.org/data/ytdata_test.tar.gz"
}
}
}
1 change: 0 additions & 1 deletion yt/utilities/grid_data_format/docs/IRATE_notes.txt
Original file line number Diff line number Diff line change
Expand Up @@ -36,4 +36,3 @@ takes care of all the details for this).
convention - that's what we've been using elsewhere in IRATE. This is
an arbitrary choice, but it would be nice for it to be consistent
throughout the format.

2 changes: 1 addition & 1 deletion yt/utilities/lib/_octree_raytracing.pyx
Original file line number Diff line number Diff line change
Expand Up @@ -44,4 +44,4 @@ cdef class _OctreeRayTracing:
self.oct.insert_node_no_ret(ii, lvl_view[i], <int> key[i])

def __dealloc__(self):
del self.oct
del self.oct
1 change: 0 additions & 1 deletion yt/utilities/lib/allocation_container.pxd
Original file line number Diff line number Diff line change
Expand Up @@ -26,4 +26,3 @@ cdef class ObjectPool:
np.uint64_t offset, np.int64_t con_id)
cdef void teardown_objs(self, void *obj, np.uint64_t n, np.uint64_t offset,
np.int64_t con_id)

2 changes: 0 additions & 2 deletions yt/utilities/lib/autogenerated_element_samplers.pxd
Original file line number Diff line number Diff line change
Expand Up @@ -77,5 +77,3 @@ cdef void W1Jacobian3D(double* rcol,
double* x,
double* vertices,
double* phys_x) nogil


2 changes: 0 additions & 2 deletions yt/utilities/lib/autogenerated_element_samplers.pyx
Original file line number Diff line number Diff line change
Expand Up @@ -177,5 +177,3 @@ cdef void W1Jacobian3D(double* rcol,
rcol[2] = -0.5*(1 - x[2])*vertices[2] + 0.5*(1 - x[2])*vertices[5] - 0.5*(1 + x[2])*vertices[11] + 0.5*(1 + x[2])*vertices[14];
scol[2] = -0.5*(1 - x[2])*vertices[2] + 0.5*(1 - x[2])*vertices[8] - 0.5*(1 + x[2])*vertices[11] + 0.5*(1 + x[2])*vertices[17];
tcol[2] = -0.5*(1 - x[0] - x[1])*vertices[2] + 0.5*(1 - x[0] - x[1])*vertices[11] - 0.5*x[0]*vertices[5] + 0.5*x[0]*vertices[14] - 0.5*x[1]*vertices[8] + 0.5*x[1]*vertices[17];


1 change: 0 additions & 1 deletion yt/utilities/lib/basic_octree.pyx
Original file line number Diff line number Diff line change
Expand Up @@ -596,4 +596,3 @@ cdef class Octree:
free(self.root_nodes[i][j])
free(self.root_nodes[i])
free(self.root_nodes)

1 change: 0 additions & 1 deletion yt/utilities/lib/cosmology_time.pyx
Original file line number Diff line number Diff line change
Expand Up @@ -81,4 +81,3 @@ cpdef friedman(double O_mat_0,double O_vac_0,double O_k_0):
tau_out[n_out] = tau

return tau_out,t_out,delta_tau,ntable,age_tot

3 changes: 0 additions & 3 deletions yt/utilities/lib/cykdtree/c_utils.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -252,6 +252,3 @@ uint32_t split(double *all_pts, uint64_t *all_idx,

return dmax;
}



1 change: 0 additions & 1 deletion yt/utilities/lib/depth_first_octree.pyx
Original file line number Diff line number Diff line change
Expand Up @@ -155,4 +155,3 @@ def RecurseOctreeByLevels(int i_i, int j_i, int k_i,
corners, grids)
curpos[level] += 1
return s

1 change: 0 additions & 1 deletion yt/utilities/lib/embree_mesh/mesh_traversal.pxd
Original file line number Diff line number Diff line change
Expand Up @@ -5,4 +5,3 @@ cimport pyembree.rtcore_scene as rtcs

cdef class YTEmbreeScene:
cdef rtcs.RTCScene scene_i

1 change: 0 additions & 1 deletion yt/utilities/lib/ewah_bool_wrap.pxd
Original file line number Diff line number Diff line change
Expand Up @@ -161,4 +161,3 @@ cdef class SparseUnorderedRefinedBitmaskVector:
cdef to_array(self)
cdef void _remove_duplicates(self)
cdef void _prune(self)

1 change: 0 additions & 1 deletion yt/utilities/lib/field_interpolation_tables.pxd
Original file line number Diff line number Diff line change
Expand Up @@ -141,4 +141,3 @@ cdef inline void FIT_eval_transfer_with_light(np.float64_t dt, np.float64_t *dvs
for i in range(3):
ta = fmax(1.0-dt*trgba[i], 0.0)
rgba[i] = (1.-ta)*trgba[i]*(1. + dot_prod*l_rgba[i]) + ta * rgba[i]

2 changes: 1 addition & 1 deletion yt/utilities/lib/fixed_interpolator.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -146,4 +146,4 @@ void eval_gradient(int ds[3], npy_float64 dp[3],
}else{
grad[0]=grad[1]=grad[2]=0.0;
}
}
}
1 change: 0 additions & 1 deletion yt/utilities/lib/fortran_reader.pyx
Original file line number Diff line number Diff line change
Expand Up @@ -318,4 +318,3 @@ def fill_child_mask(np.ndarray[np.int64_t, ndim=2] file_locations,
for y in range(2):
for z in range(2):
child_mask[lex+x,ley+y,lez+z] = art_child_masks[ioct,x,y,z]

1 change: 0 additions & 1 deletion yt/utilities/lib/fp_utils.pxd
Original file line number Diff line number Diff line change
Expand Up @@ -58,4 +58,3 @@ cdef inline _ensure_code(arr):
return arr
arr.convert_to_units("code_length")
return arr

2 changes: 0 additions & 2 deletions yt/utilities/lib/grid_traversal.pyx
Original file line number Diff line number Diff line change
Expand Up @@ -367,5 +367,3 @@ def arr_fisheye_vectors(int resolution, np.float64_t fov, int nimx=1, int
vp[i,j,1] = sin(theta) * sin(phi)
vp[i,j,2] = cos(theta)
return vp


1 change: 0 additions & 1 deletion yt/utilities/lib/lenses.pyx
Original file line number Diff line number Diff line change
Expand Up @@ -205,4 +205,3 @@ cdef void generate_vector_info_null(ImageSampler im,
# since vp_pos has funny strides.
v_pos[i] = im.vp_pos[vi, vj, i]
v_dir[i] = im.vp_dir[vi, vj, i]

1 change: 0 additions & 1 deletion yt/utilities/lib/marching_cubes.pyx
Original file line number Diff line number Diff line change
Expand Up @@ -398,4 +398,3 @@ def march_cubes_grid_flux(
# Hallo, we are all done.
WipeTriangles(triangles.first)
return flux

5 changes: 0 additions & 5 deletions yt/utilities/lib/particle_mesh_operations.pyx
Original file line number Diff line number Diff line change
Expand Up @@ -373,8 +373,3 @@ def recursive_particle_assignment(grids, grid,
recursive_particle_assignment(grids,grid,left_edges,right_edges,
pos_x[assigned],pos_y[assigned],pos_z[assigned])
#now we have assigned particles to other subgrids, we are left with particles on our grid





1 change: 0 additions & 1 deletion yt/utilities/lib/partitioned_grid.pxd
Original file line number Diff line number Diff line change
Expand Up @@ -27,4 +27,3 @@ cdef class PartitionedGrid:
cdef np.float64_t star_coeff
cdef void get_vector_field(self, np.float64_t pos[3],
np.float64_t *vel, np.float64_t *vel_mag)

1 change: 0 additions & 1 deletion yt/utilities/lib/partitioned_grid.pyx
Original file line number Diff line number Diff line change
Expand Up @@ -157,4 +157,3 @@ cdef class PartitionedGrid:
if vel_mag[0] != 0.0:
for i in range(3):
vel[i] /= vel_mag[0]

2 changes: 1 addition & 1 deletion yt/utilities/lib/platform_dep.h
Original file line number Diff line number Diff line change
Expand Up @@ -59,4 +59,4 @@ double erf(double x)
#include <stdint.h>
#include "alloca.h"
#include <math.h>
#endif
#endif
2 changes: 1 addition & 1 deletion yt/utilities/lib/platform_dep_math.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -15,4 +15,4 @@ inline bool __isnormal(double x) {
inline bool __isnormal(double x) {
return std::isnormal(x);
}
#endif
#endif
2 changes: 1 addition & 1 deletion yt/utilities/lib/tsearch.h
Original file line number Diff line number Diff line change
Expand Up @@ -23,4 +23,4 @@ void * tdelete(const void *vkey, void **vrootp,
int (*compar)(const void *, const void *));


#endif
#endif

0 comments on commit 5e5ce14

Please sign in to comment.