GitHub - Gist 一覧

よろしければ、参考にしてください。
477 件
ファイル名説明
regression_logistic.cppC++ source code to compute logistic regression.
eigen_test.cppC++ source code to test C++ matrix library Eigen.
logistic_regression.rbRuby script to calculate a logistic regression.
regression_curve_5d.cppC++ source code to calculate a simple regression curve(5d).
regression_curve_5d.rbRuby script to calculate a simple regression curve.(5d)
gauss_elimination_pivot.cppC++ source code to solve simultaneous equations with Gauss elimination method(pivot).
gauss_elimination_pivot.f95Fortran95 source code to solve simultaneous equations with Gauss elimination method(pivot).
gauss_elimination_pivot.rbRuby script to solve simultaneous equations with Gauss elimination method(pivot).
date_loop.shBash script to loop by date.
make_eop.cppC++ source code to make an EOP(Earth Orientation Parameters) file.
blh2enu.cppC++ source code to convert a coordinate from WGS84(BLH) to ENU.
ecef2blh.cppC++ source code to convert a coordinate from ECEF to WGS84(BLH).
blh2ecef.cppC++ source code to convert a coordinate from WGS84(BLH) to ECEF.
mean_time.cppC++ source code to calculate a mean of 2 timespecs.
lorenz_attractor_runge_kutta.cppC++ source code to calculate a Lorenz attractor by Runge-Kutta's method.
lorenz_attractor_euler.cppC++ source code to calculate a Lorenz attractor by Euler's method.
infix2rpn_bt.cppC++ source code to convert a formula string to a RPN with a binary tree.
rpn.cppC++ source code to calculate a formula expressed with RPN.
infix2rpn.cppC++ source code to convert a formula string to a RPN.
infix2rpn_bt.rbRuby script to convert a formula string to a RPN by binary tree.
rpn.rbRuby script to calculate a formula expressed with RPN.
infix2rpn.rbRuby script to convert a formula string to a RPN.
vincenty_destination.cppC++ source code to calculate geodesical values by Vincenty's formulae.(destination)
vincenty_distance.cppC++ source code to calculate geodesical values by Vincenty's formulae.(distance)
rcc_kendall.cppC++ source code to calculate a Kendall's Rank Correlation Coefficient.
rcc_spearman.cppC++ source code to calculate a Spearman's Rank Correlation Coefficient.
rank_2.cppC++ source code to rank, considering same ranks(mid-rank method).
rank.cppC++ source code to rank, considering same ranks.
common.hppC++ source code to calculate binomial coefficients.
is_real.cppC++ source code to judge if a string is an real number.
is_integer.cppC++ source code to judge if a string is an integer.
factorial.cppC++ source code to calculate factorials with GMP.
spline_interpolation.cppC++ source code to interpolate by 3D-Spline.
lu_decomposition_crout.cppC++ source code to do LU-decomposition by Crout method.
lu_decomposition_inner_product.cppC++ source code to do LU-decomposition by inner-product form.
lu_decomposition_outer_product.cppC++ source code to do LU-decomposition by outer-product form.
file.hppC++ source code to calculate an adjusted coefficent of determination for multiple regression.
regression_multi_2e_2d.cppC++ source code to compute multiple regression equations.(2d)
gistfile1.txtC++ source code to compute multiple regression equations.(3 explanatory variables)
regression_multi_2e.cppC++ source code to compute multiple regression equations.
file.hppC++ source code to calculate a coefficent of determination for simple 2D regression.
file.hppC++ source code to calculate a coefficent of determination for simple linear regression.
regression_curve_exp_e.cppC++ source code to calculate a simple regression curve(exp_e).
regression_curve_pow.cppC++ source code to calculate a simple regression curve(exp).
regression_curve_pow.cppC++ source code to calculate a simple regression curve(pow).
regression_curve_frac.cppC++ source code to calculate a simple regression curve(frac).
regression_curve_ln.cppC++ source code to calculate a simple regression curve(ln).
regression_curve_sqrt.cppC++ source code to calculate a simple regression curve(sqrt)
regression_curve_4d.cppC++ source code to calculate a simple regression curve(4d).
regression_curve_3d.cppC++ source code to calculate a simple regression curve(3d).
regression_curve_2d.cppC++ source code to calculate a simple regression curve(2d).
regression_line.cppC++ source code to calculate a simple linear regression line.
test_csv.cppC++ source code to read csv data(v2).
inverse_matrix.f95Fortran 95 source code to calculate an inverse matrix by cofactor matrix.
determinant.f95Fortran 95 source code to calculate a determinant by cofactor expansion.
test_inverse_matrix.rbRuby script to calculate an inverse matrix by cofactor matrix.
test_determinant.rbRuby script to calculate a determinant by cofactor expansion.
adjusted_coefficient_of_determination.f95Fortran 95 source code to calculate an adjusted coefficent of determination for multiple regression.
adjusted_coefficient_of_determination.rbRuby script to calculate an adjusted coefficient of determination.
regression_multi_3e.f95Fortran 95 source code to compute multiple regression equations.(3 explanatory variables)
regression_multi_3e.rbRuby script to compute multiple regression equations.(3 explanatory variables)
calc_rcc_kendall.f95Fortran 95 source code to calculate a Kendall's Rank Correlation Coefficient.
calc_rcc_spearman.f95Fortran 95 source code to calculate a Spearman's Rank Correlation Coefficient.
calc_rcc_spearman.rbRuby script to calculate a Kendall's Rank Correlation Coefficient.
calc_rcc_spearman.rbRuby script to calculate a Spearman's Rank Correlation Coefficient.
binom_coeff.f95Fortran 95 source code to calculate binomial coefficients.
test_binom.rbRuby script to calculate binomial coefficients.
calc_central_angle.rbRuby script to calculate a central angle betweetn 2 points on earth.
calc_vincenty.rbRuby script to calculate geodesical values by Vincenty's formulae.
regression_multi_2d.f95Fortran 95 source code to compute multiple regression equations.(2d)
regression_multi_2d.rbRuby script to calculate a multiple regression function.(2d)
regression_multi_v2.f95 Fortran 95 source code to compute multiple regression equations.(v2)
regression_curve_exp_e.f95Fortran 95 source code to calculate a simple regression curve.(exp_e)
regression_curve_exp.f95Fortran 95 source code to calculate a simple regression curve.(exp)
regression_curve_pow.f95Fortran 95 source code to calculate a simple regression curve.(power)
regression_curve_frac.f95Fortran 95 source code to calculate a simple regression curve.(frac)
regression_curve_ln.f95Fortran 95 source code to calculate a simple regression curve.(ln)
regression_curve_sqrt.f95Fortran 95 source code to calculate a simple regression curve.(sqrt)
regression_curve_4d.f95Fortran 95 source code to calculate a simple regression curve.(4d)
regression_curve_3d.f95Fortran 95 source code to calculate a simple regression curve.(3d)
regression_curve_exp_e.rbRuby script to calculate a simple regression curve.(exp_e)
regression_curve_exp.rbRuby script to calculate a simple regression curve.(exp)
regression_curve_pow.rbRuby script to calculate a simple regression curve.(power)
regression_curve_frac.rbRuby script to calculate a simple regression curve.(frac)
regression_curve_ln.rbRuby script to calculate a simple regression curve.(ln)
regression_curve_sqrt.rbRuby script to calculate a simple regression curve.(sqrt)
regression_curve_4d.rbRuby script to calculate a simple regression curve.(4d)
regression_curve_3d.rbRuby script to calculate a simple regression curve.(3d)
coefficient_of_determination_2d.f95Fortran source code to calculate a coefficent of determination for simple 2D regression.
coefficient_of_determination_line.f95Fotran source code to calculate a coefficent of determination for simple linear regression.
coefficient_of_determination_2d.rbRuby script to calculate a coefficent of determination for simple 2D regression.
coefficient_of_determination_line.rbRuby script to calculate a coefficent of determination for simple linear regression.
regression_curve_2.f95Fortran 95 source code to compute a simple regression curve(2d)(ver.2).
regression_curve.f95Fortran 95 source code to compute a simple regression curve(2d).
regression_line_2.f95Fortran 95 source code to calculate a simple linear regression line.(Ver.2)
regression_curve_2.rbRuby script to calculate a simple linear regression curve.(Ver.2)
regression_line_2.rbRuby script to calculate a simple linear regression line.(Ver.2)
sle_lu.f95Fortran 95 source code to solve simultaneous equations by LU-decomposition(outer-product form).
sle_lu.rbRuby script to solve simultaneous equations by LU-decomposition(outer-product form).
lu_decomposition_3.f95Fortran 95 source code to do LU-decomposition by Crout method.
lu_decomposition_2.f95Fortran 95 source code to do LU-decomposition by inner-product form.
lu_decomposition.f95Fortran 95 source code to do LU-decomposition by outer-product form.
lu_decomposition_3.rbRuby script to do LU-decomposition by Crout method.
lu_decomposition_2.rbRuby script to do LU-decomposition by inner-product form.
lu_decomposition.rbRuby script to do LU-decomposition by outer-product form.
blh2enu.f95Fortran 95 source code to convert WGS84(BLH) to ENU coordinate.
ecef2blh.f95Fortran 95 source code to convert ECEF to WGS84(BLH) coordinate.
blh2ecef.f95Fortran 95 source code to convert WGS84(BLH) to ECEF coordinate.
blh2enu.rbRuby script to convert WGS84(BLH) to ENU coordinate.
ecef2blh.rbRuby script to convert ECEF to WGS84(BLH) coordinate.
blh2ecef.rbRuby script to convert WGS84(BLH) to ECEF coordinate.
blh2enu.pyPython script to convert WGS84(BLH) to ENU coordinate.
tweet_oauth.rbRuby script to tweet with image files.
spline_interpolation.f95Fortran 95 source code to compute 3D Spline interpolation.
modular exponentiation_2.f95Fortran 95 source code to compute modular exponetiation recursively.
modular exponentiation_1.f95Fortran 95 source code to compute modular exponetiation iteratively.
regression_multi.f95Fortran 95 source code to compute multiple regression equations.
regression_line.f95Fortran 95 source code to compute a simple linear regression line.
correlation_coefficient.f95Fortran 95 source code to compute a correlation coefficient.
discrete_fourier_transformation.f95Fortran 95 source code to compute discrete Fourier transformation.
fourier_series_expansion.f95Fortran 95 source code to expand Fourier's series.
newton_interpolation.f95Fortran 95 source code to interpolate by Newton's method.
lagrange_interpolation.f95Fortran 95 source code to interpolate by Lagrange's method.
taylor_expansion_cos.f95Fortran 95 source code to computer Taylor expansion(cos(x)).
taylor_expansion_exp.f95Fortran 95 source code to computer Taylor expansion(exp(x)).
sort_test.f95Fortran 95 source code to test sorting algorithms.
heap_downward.f95Fortran 95 source code to generate a heap by downward method.
heap_upward.f95Fortran 95 source code to generate a heap by upward method.
simplex.f95Fortran 95 source code to solve a linear programming by simplex method.
gauss_elimination.f95Fortran 95 source code to solve simultaneous equations by Gauss elimination method.
gauss_jordan_pivot.f95Fortran 95 source code to solve simultaneous equations by Gauss-Jordan's method(pivot).
gauss_jordan.f95Fortran 95 source code to solve simultaneous equations by Gauss-Jordan's method.
rndnum_mb.f95Fortran 95 source code to generate random numbers by box-muller's method.
pgmout.cFortran 95 source code to test cellular-automaton implementation.(Ver.2)
pi_chudnovsky.f95Fortran 95 source code to compute PI with FMLIB, using Chudnovsky formula.
napier.f95Fortran 95 source code to compute Napier's constant with FMLIB.
asc2eph.f95Fortran 95 source code to convert JPL source cord from ascii to binary
definite_integral.f95Fortran 95 source code to compute a definite integral.
nonlinear_equation_newton.f95Fortran 95 source code to solve nonlinear-equation with newton method.
nonlinear_equation_bisection.f95Fortran 95 source code to solve nonlinear-equation with bisection method.
pgmout.cFortran 95 source code to generate 2D-fractal by complex convergence method.
cell_atm.f95Fortran 95 source code to test cellular-automaton implementation.
stack.f95Fortran 95 source code to compute with Reverse Polish Notation method.
test_stack.f95Fortran 95 source code to test stack implementation.
fibonacci.f95Fortran 95 source code to compute the Fibonacci-series.
rosseland_mean.f95Fortran 95 source code to compute the rosseland-maen.
fibonacci_2.f95Fortran 95 source code to compute the Fibonacci-series.(Ver.2)
rosseland_mean_2.f95Fortran 95 source code to compute the rosseland-maen.(Ver.2)
factorial.f95Fortran 95 source code to compute the factorial.
gcd.f95Fortran 95 source code to compute the G.C.D.
mv_product.f95Fortran 95 source code to compute the product of matrix and vetor.
inner_product_2.f95Fortran 95 source code to compute inner-product of vetors(Ver.2).
inner_product.f95Fortran 95 source code to compute inner-product of vetors.
test_mecab.pyPython script to test of MeCab.
tweet_v2.pyPython script to tweet with medias by OAuth only.
iss_sgp4.pyPython script to calclulate the ISS position/velocity with SGP4 algorithm.
get_eop_csv.pyPython script to generate csv data from IERS's EOP.
get_eop_csv.rbRuby script to generate csv data from IERS's EOP.
ecef2blh.pyPython script to convert ECEF to WGS84(BLH) coordinate.
blh2ecef.pyPython script to convert WGS84(BLH) to ECEF coordinate.
verify_gc2jd_2.rbRuby script to verify of converting Gregorian Calendar to Julian Day.(v2)
get_delta_t_usno.pyPython script to get delta_T from USNO.
get_delta_t_usno.rbRuby script to get delta_T from USNO.
tle_iss_nasa.pyPython script to get TLE from NASA.
tle_iss_nasa.rbRuby script to get TLE from NASA.
calc_gmst_iau_1982.pyPython script to calculate GMST with IAU1982 theory.
calc_gmst_iau_1982.rbRuby script to calculate GMST with IAU1982 theory.
trigonometric.pyPython script to convert coordinates.
time.pyGist - Python script to convert time series.
calc_delta_t.pyPython script to calculate deltaT by NASA method.
mean_obliquity_ecliptic.pyPython script to calc a Mean Obliquity of the Ecliptic.
lib_read_de430.pyPython script to calc ICRS coordinates with JPL binary data DE430.
lorenz_attractor_runge_kutta.pyPython script to draw a lorenz attractor with Runge-Kutta's method.
lorenz_attractor_euler.pyPython script to draw a lorenz attractor with Euler's method.
lorenz_attractor_runge_kutta.rbRuby script to draw a lorenz attractor with Runge-Kutta's method.
lorenz_attractor_euler.rbRuby script to draw a lorenz attractor with Euler's method.
jpl_read_de430.pyPython script to read a jpl binary data DE430.
str_trunc.pyPython script to truncate string, including multi-byte characters.
tinyurl_shorten.pyPython script to shorten a url with TinyURL API.
bitly_shorten.pyPython script to shorten a url with bitly API.
test_subprocess.pyPython script to test an execution of external commands by subprocess.
test_signal.pyPython script to test interrupt handling by signal.
test_daemon.pyPython script to do a process as a daemon.
regression_multi_numpy.pyPython script to compute multiple regression equation with NumPy.
regression_line_curve.py Python script to compute regression line/curve(1-4D).
pi_chudnovsky.pyPython script to compute pi with Chudnovsky formula and Binary Splitting Algorithm, using GMP libarary.
regression_curve.pyPython script to compute regression curve.
regression_curve.rbRuby script to calculate a simple regression curve.
spline_interpolation.pyPython script to calc 3D-Spline-Interpolation.
modular_exponentiation_2.pyPython script to compute modular-exponentiation recursively.
modular_exponentiation_1.pyPython script to compute modular-exponentiation iteratively.
regression_multi.pyPython script to compute multiple regression equation.
regression_line.pyPython script to compute regression line.
correlation_coefficient.pyPython script to compute correlation coefficient.
sort_test.pyPython script to test sorting algorithms.
sort_test.cppC++ source code to test sorting algorithms.
heap_downward.pyPython script to generate a heap by the downward method.
heap_upward.pyPython script to generate a heap by the upward method.
heap_downward.cppC++ source code to generate a heap with the downward method.
heap_upward.cppC++ source code to generate a heap with the upward method.
least_squares_method.pyPython script to solve approximate equation with least squares method.
LeastSquaresMethod.javaJava source code to solve approximate equation with least squares method.
least_squares_method.f95Fortran95 source code to solve approximate equation with least squares method.
least_squares_method.cppC++ source code to solve approximate equation with least squares method.
linear_programming_simplex.pyPython script to execute linear programming with Simplex method.
linear_programming.cppC++ source code to execute linear programming with Simplex method.
gauss_elimination.pyPython script to solve simultaneous equations with Gauss elimination method.
gauss_elimination.cppC++ source code to solve simultaneous equations with Gauss elimination method.
gauss_jordern_pivot.pyPython script to solve simultaneous equations with Gauss-Jorden(pivot) method.
gauss_jordern_pivot.cppC++ source code to solve simultaneous equations with Gauss-Jorden(pivot) method.
gauss_jordern.pyPython script to solve simultaneous equations with Gauss-Jorden method.
gauss_jordern.cppC++ source code to solve simultaneous equations with Gauss-Jorden method.
discrete_fourier_transform.pyPython script to compute discrete Fourier transform.
discrete_fourier_transform.cppC++ source code to compute discrete Fourier transform
fourier_series_expansion.pyPython script to expand Fourier's series.
fourier_series_expansion.cppC++ source code to expand Fourier's series.
add_big_float.pyPython script to compute big-digit floats.
add_big_float.cppC++ source code to compute big-digit floats.
compare_big_digits.pyPython script to compare big digits.
compare_big_digits.cppC++ source code to compare big digits.
multiply_toom_cook_3.pyPython script to multiply big-digit values with Toom-Cook 3-way method.
multiply_toom_cook_3.cppC++ source code to multiply big-digit values with Toom-Cook 3-way method.
multiply_karatsuba.pyPython script to multiply big-digit values with Karatsuba method.
multiply_karatsuba.cppC++ source code to multiply big-digit values with Karatsuba method.
str_trunc.rbRuby script to truncate string, including multi-byte characters.
multiply_normal.pyPython script to multiply big-digit values.
multiply_normal.cppC++ source code to multiply big-digit values.
calc_big_digits_2.pyPython script to compute big-digit values.(v2)
calc_big_digits_2.cppC++ source code to compute big-digit values.(v2)
calc_pi_arctan.f95Fortran source code to compute Pi with arctan's formula.
calc_pi_arctan.pyPython script to compute Pi with arctan's formula.
calc_pi_arctan_2.cppC++ source code to compute Pi with arctan's formula.(v2)
calc_pi_arctan.rbRuby script to compute Pi with arctan's formula.
calc_pi_arctan.cppC++ source code to compute Pi with arctan's formula.
calc_pi_arctan_old.cppC++ source code to compute Pi with arctan's formula.(old ver.)
calc_pi_euler.pyPython script to compute Pi with Euler's formula.
calc_pi_euler.cppC++ source code to compute Pi with Euler's formula.
calc_pi_klingenstierna.pyPython script to compute Pi with Klingenstierna's formula.
calc_pi_klingenstierna.cppC++ source code to compute Pi with Klingenstierna's formula.
calc_factorial.pyPython script to compute factorials.
calc_factorial.cppC++ source code to compute factorials.
calc_napier.pyPython script to compute Napier constant.
calc_napier.cppC++ source code to compute Napier's constant.
calc_pi_machin.pyPython script to compute Pi with Machin's formula.
calc_pi_machin.cppC++ source code to compute Pi with Machin's formula.
calc_big_digits.pyPython script to compute big-digit values.
calc_big_digits.cppC++ source code to compute big-digit values.
interpolate_newton.pyPython script to interpolate with Newton method.
interpolate_newton.cppC++ source code to interpolate with Newton method.
interpolate_lagrange.pyPython script to interpolate with Lagrange method.
interpolate_lagrange.cppC++ source code to interporate with Lagrange method.
nonlinear_equation_newton.pyPython script to compute nonlinear equation with Newton method.
nonlinear_equation_newton.rbRuby script to compute nonlinear equation with Newton method.
nonlinear_equation_newton.cppC++ source code to compute nonlinear equation with Newton method.
nonlinear_equation.pyPython script to compute nonlinear equation with bisection method.
nonlinear_equation.rbRuby script to compute nonlinear equation with bisection method.
nonlinear_equation.cppC++ source code to compute nonlinear equation with bisection method.
taylor_expansion_cos.pyPython script to compute Taylor expansion (cos(x)).
taylor_expansion_cos.rbRuby script to compute Taylor expansion (cos(x)).
taylor_expansion_cos.cppC++ source code to compute Taylor expansion (cos(x)).
taylor_expansion.pyPython script to compute Taylor expansion (exp(x)).
taylor_expansion.rbRuby script to compute Taylor expansion (exp(x)).
taylor_expansion.cppC++ source code to compute Taylor expansion (exp(x)).
definite_ingegral_simpson.pyPython script to compute definite integral by simpson rule.
definite_ingegral_simpson.rbRuby script to compute definite integral by Simpson rule.
definite_ingegral_simpson.cppC++ source code to compute definite integral by Simpson rule.
definite_ingegral_trapezoid.pyPython script to compute definite integral by trapezoidal rule.
definite_ingegral_trapezoid.rbRuby script to compute definite integral by trapizoidal rule.
definite_ingegral_trapezoid.cppC++ source code to compute definite integral by trapizoidal rule.
rndnum_box_muller.pyPython script to generate random numbers with Box-Muller algorithm.
rndnum_box_muller.rbRuby script to compute random number with Box-Muller algorithm.
rndnum_box_muller.cpp C++ source code to compute random number with Box-Muller algorithm.
chi_2_rndnum.pyRuby script to test for uniformity of random number with Chi-square algorithm.
chi_2_rndnum.rbRuby script to test for uniformity of random number with Chi-square algorithm.
chi_2_rndnum.cppC++ source code to test for uniformity of random number with Chi-square algorithm.
rndnum_lcgs.pyPython script to generate random numbers with LCGs algorithm.
rndnum_lcgs.rbRuby script to compute random number with LGGs algorithm.
rndnum_lcgs.cppC++ source code to compute random number with LGGs algorithm.
prime_factorization.pyPython script to compute prime fractorization.
prime_factorization.rbRuby script to compute prime factorizatiton.
prime_factorization.cppC++ source code to compute prime factorizatiton.
prime_number.pyPython script to judge prime number.
prime_number.cppC++ source code to judge prime number.
gcd_euclid.pyPython script to compute G.C.D. with Eublid's algorithm.
gcd_euclid.rbRuby script to compute G.C.D. with Euclid's algorithm.
gcd_euclid.cppC++ source code to compute G.C.D. with Euclid's algorithm.
tweet.pyPython script to tweet with OAuth only.
pycall_sgp4.rbSample script of Ruby to use Python with PyCall.
gmt_aep.shBash script to draw maps with Azimuthal Equidistant Projection.
linked_list_by_pointer.f95Fortran code to generate linked-list by pointer.
to_uppercase.f95Fortran code to convert chars to uppercase.
prime_numbers.f95Fortran code to compute prime numbers.
double_precision_real.f95Fortran code to specify floating-point numbers.
series.f95Fortran code to calculate series.
rndnum_lcg.f95Fortran code to calculate random numbers by lcg method.
tweet_oauth.rbRuby script to tweet with only OAuth.
read_csv.cppC++ source code to read csv data.
validation.hppC++ source code to check date validation.
analyze_tweetid.rbRuby script to get a timestamp from a tweet-id.
tumblr_text.rbRuby script to post texts to Tumblr.
get_access_token_tumblr.rbRuby script to get Tumblr access token from consumer key.
conv_camel_snake.rbRuby script to convert CamelCase and snake_case each other.
cal_jpl.rbRuby script to calculate a Japan's calendar with a selfmade gem library, using JPL DE430.
apparent_sun_moon_jpl.rbRuby script to calculate apparent position of Sun and Moon.
conv_time.rbRuby script to convert time system.
calc_greenwich_time.rbRuby script to calculate Greenwich times.
coord_conversion.rbRuby script to convert celestial coordinates.
bpn_rotation.rbRuby script to apply Bias-Precession-Nutation to a rectanglar coordinate.
get_dut1_nict.rbRuby script to get a list of DUT1 adjustment.
get_leapsec_nict.rbRuby script to get a list of leap-second adjustment.
calc_schwarzschild_radius.rbRuby script to calculate Schwarzschild radius.
jpl_distance_earth.rbRuby script to calculate planetary distances.
jpl_planetary_mass.rbRuby script to calculate planetary masses from JPL DE430.
ephemeris_jpl.rbRuby script to calculate JPL ephemeris with a selfmade gem library.
calc_delta_t.rbRuby script to calculate deltaT by NASA method.
verify_jd2gc.rbRuby script to verify of converting Julian Day to Gregorian Calendar.
verify_gc2jd.rbRuby script to verify of converting Gregorian Calendar to Julian Day.
sun_moon.rbRuby script to calculate a Japan's Sun/Moon phenomenons with a selfmade gem library.
calendar.rbRuby script to calculate a Japan's calendar with a selfmade gem library.
mean_obliquity_ecliptic.rbRuby script to calc a Mean Obliquity of the Ecliptic.
JAPAN_ETOPO1_b.shBash script to paint a Japan's elevetion map by GMT(Albers).
JAPAN_ETOPO1.shBash script to paint a Japan's elevetion map by GMT(Mercator).
rmagick_watermark.rbRuby script to write a watermark by rmagick.
jpl_calc_de430.rbRuby script to calc ICRS coordinates with JPL binary data DE430.
jpl_read_de430.rbRuby script to read a jpl binary data DE430.
check_string_similarity_by_ngram.rbRuby script to check a degree of string similarity by n-gram model
tinyurl_shoten_2.rbRuby script to shorten a url by TinyURL.(ver.2)
tinyurl_shorten.rbRuby script to shorten a url by TinyURL.
fr24_airlines.rbRuby script to get a airline list from Flightradar24.
fr24_airports.rbRuby script to get a airport list from Flightradar24.
spline_interpolation.rbRuby script to calc 3D-Spline-Interpolation.
db_dump_only_data_by_split.shBash script to dump only records of MariaDB(MySQL) tables by split.
test_nokogiri_xml.rbRuby script to verify the speed of xml parsing by Nokogiri.
table_definition.xslXSL template to generate a HTML from a XML of MariaDB(MySQL)'s table definition.
gnuplot_3.rbRuby script to draw a graph by gnuplot.(Ex.3)
gnuplot_2.rbRuby script to draw a graph by gnuplot.(Ex.2)
gnuplot_1.rbRuby script to draw a graph by gnuplot.(Ex.1)
array_rank.rbRuby script to rank array items, considering same ranks.
get_mail.rbRuby script to get a mail via alias of postfix.
chudnovsky.rbRuby script to compute pi by Chudnovsky formula and Binary Splitting Algorithm using GMP libarary.
pi_bbp.rbRuby script to compute pi with BBP formula.
pi_bbp.cppC++ source code to compute pi with BBP formula.
modular_exponentiation_2.rbRuby script to compute modular-exponentiation recursively.
modular_exponentiation_1.rbRuby script to compute modular-exponentiation iteratively.
ModularExponentiation2.cppC++ source code to compute modular exponetiation recursively.
ModularExponentiation1.cppC++ source code to compute modular exponetiation iteratively.
chudnovsky.cppC++ source code to compute pi with Chudnovsky formula and Binary Splitting Algorithm using GMP libarary.
test_gmp.cppC++ source code to calculate values with GMP library.
send_mail.rbRuby script to send a ISO-2022-JP mail.
test_gmp.cC source code to calculate values with GMP library.
socket_client.rbRuby script to test for socket connection.(Client-side)
socket_server.rbRuby script to test for socket connection.(Server-side)
geo_ruby_nsew.rbRuby script to get NorthSouthEastWest ends from shapefile.
geo_ruby_geometry.rbRuby script to read geometric datas from shapefile.
jartic.rbRuby script to get road closing informations from JARTIC.
calc_pressure.rbRuby script to calculate values about pressure.
twitter_settings.rbRuby script to set informations of a twitter account.
problem_2038.rbRuby script to calc remaining seconds to the date of Problem-2038.
JAPAN_ETOPO1.shBash script to paint a map with elevation data.
prime_number_list.rbRuby script to list prime numbers.
prime_number_2.rbRuby script to calculate Xth prime number.
prime_number_1.rbRuby script to check a prime number.
test_bash_cursor_2.shBash script to control cursor position.(Ex.2)
test_bash_cursor_1.shBash script to control cursor position.(Ex.1)
check_html.rbRuby script to check a difference between a saved-html and a current-html.
check_twitter_accounts.rbRuby script to check existance of twitter accounts.
ps_check.shBash script to check processes.
ts_test.rbRuby script to get tweet statuses by tweetstream library.
json_stream.rbRuby script to get tweet statuses by twitter-stream gem library.
japan_okinawa.RR scirpt to draw a map of Japan. (Okianwa Division Ver.)
japan_standard.RR scirpt to draw a map of Japan. (Standard Ver.)
TwitterStream.cppC++ source code to get twitter timelines by Twitter Streaming API.
YamlCpp03.cppC++ source code to get yaml informations by yaml-cpp 0.3 series.
regression_multi.rbRuby script to calculate a multiple regression function.
PicoJson.cppC++ source code to parse json datas by picojson.
check_html.shBash script to check a difference between a saved-html and a current-html.
regression_line.rbRuby script to calculate a simple linear regression line.
correlation_coefficient.rbRuby script to calculate a correlation coefficient.
YamlCpp.cppC++ source code to get yaml informations by yaml-cpp.
population_density_pref.RR script to generate a choropleth map of Japan's population density.
geo_ruby.rbRuby to read a shapefile with georuby.
SubStrUtf8.cppC++ source code to get substrings of UTF-8.
CntStrUtf8.cppC++ source code to count strings of UTF-8.
Twitcurl.cppC++ source code to tweet by twitcurl library.
Mysql.cppC++ source code to connect to MariaDB(MySQL).
BoostRegexR.cppC++ source code to replace regular expressions by boost.
BoostRegexI.cppC++ source code to match regular expressions using iterators by boost.
BoostRegexW.cppC++ source code to match regular expressions(wchar) by boost.
BoostRegex.cppC++ source code to match regular expressions by boost.
SjistToUtf8.cppGist - C++ source code to convert ShiftJIS to UTR-8.
GetHtml.cppC++ source code to get HTML.
test_maptools_ksj.RR script to generate a map of KSJ by maptools.
earthquake.RR script to plot earthquake infos on a map.
test_maptools.RR script to generate a map by maptools.
test_xml.rbRuby script to do tests of parsing xml with Nokogiri, Hpricot parsers.
sort_test.rbRuby script to test sorting algorithms.
heap_downward.rbRuby script to generate a heap by the downward method.
heap_upward.rbRuby script to generate a heap by the upward method.
metar.shBash script to get a METAR information.
noaa_weather_station.shBash script to search NOAA weather stations by a ICAO code.
noaa_stations.rbRuby script to calculate a summary of the list of NOAA's weather stations.
check_df.shBash script to check the capacity of disk partitions.
twitter_access_token.rbRuby script to get twitter access token from consumer key.
write_excel.rbRuby script to write a Excel workbook by 'spreadsheet'.
read_excel.rbRuby script to read a Excel workbook by 'spreadsheet'.
iso_3166_2_jp.csvCSV file of ISO 3166-2:JP.
iso_3166_1.csvCSV file of ISO 3166-1.
least_squares_method.rbRuby script to solve approximate equation with least squares method.
linear_programming_simplex.rbRuby script to execute linear programming with Simplex method.
search_mac.rbRuby scripts to search a vendor name from a MAC address.
push_controller.rbRails controller to receive feeds from the Hub of PubSubHubbub.
test_daemonShell script to start a daemon.
test_daemon.rbRuby script testing to daemonize a ruby script.
test_tweetstream.rbRuby script testing to get tweets by tweetstream.
gauss_elimination.rbRuby script to solve simultaneous equations with Gauss elimination method.
gauss_jorden_pivot.rbRuby script to solve simultaneous equations with Gauss-Jorden(pivot) method.
gauss_jorden.rbRuby script to solve simultaneous equations with Gauss-Jorden method.
csv2table.rbRuby script to convert a csv file to html table tags.
rmagick_compile_color.rbRuby script to compile colors in a image with RMagick.
fb_api_likes.rbRuby script to get a list of Facebook likes by Facebook API.
fb_api.rbRuby script to get Facebook user informations by Facebook API.
write_copyright.rbRuby script to write characters to a image file by RMagick.
rmagick_available_fonts.rbRuby script to generate a image of available fonts on RMagick.
get_link_list_md.rbRuby script to get a link list from markdown files in a directory recursively.
rmagick_img_info.rbRuby script to get informations of a image file by RMagick.
check_link.rbRuby script to check link in a web site.
calc_num_of_days.rbRuby script to calc the number of days.
bitly_shorten.rbRuby script to shorten a long url to a short url by bitly API V3.
google_maps_dist.jsJavaScript file to calc distance between two spots with Google Maps API v3.
octokit_gists.rbRuby script to get gist lists by octokit.
octokit_repositories.rbRuby script to get github repositories by octokit.
google_geocode.rbRuby script to get a address or latitude, longitude with Google Geocoding API.
discrete_fourier_transform.rbRuby script to compute discrete Fourier transform.
.tmux.conftmux config(setting) file.
fourier_series_expansion.rbRuby script to expand Fourier's series.
compare_big_digits.rbRuby script to compare big digits.
add_big_float.rbRuby script to compute big-digit floats.
multiply_toom_cook_3.rbRuby script to multiply big-digit values with Toom-Cook 3-way method.
multiply_karatsuba.rbRuby script to multiply big-digit values with Karatsuba method.
multiply_normal.rbRuby script to multiply big-digit values.
calc_big_digits_2.rbRuby script to compute big-digit values.(v2)
cal_pi_arctan_2.rbRuby script to compute Pi with arctan's formula.(v2)
calc_pi_arctan_old.rbRuby script to compute Pi with arctan's formula.(old ver.)
ccalc_pi_euler.rbRuby script to compute Pi with Euler's formula.
calc_pi_klingenstierna.rbRuby script to calc pi by Klingenstierna formula.
tweet_with_image.rbRuby script to tweet with image files.
calc_factorial.rbRuby script to compute factorials.
calc_napier.rbRuby script to compute Napier's constant.
calc_pi_machin.rbRuby script to compute Pi with Machin's formula.
calc_big_digits.rbRuby script to compute big-digit values.
interpolate_newton.rbRuby script to interpolate with Newton method.
measure_benchmark.rbRuby script to measure benchmarks.
calc_pi_spigot_2.rbRuby script no.2 to calc the ratio of the circumference of a circle to its diameter by spigot algorythm.
calc_pi_spigot_1.rbRuby script to calc the ratio of the circumference of a circle to its diameter by spigot algorythm.
prime_number.rbRuby script to judge a prime number.
eratosthenes.rbRuby script to calc eratosthenes.
prime_decomposition.rbRuby script to decomposit a prime number.
rndnum_lcgs.rbRuby script to calc uniform random numbers by LCGs method.
chi2_rndnum.rbRuby script to calc uniform random numbers by chi-squared distribution method.
rndnum_box_muller.rbRuby script to calc normal random numbers by box-muller method.
definite_integral_trapzoid.rbRuby script to definite integral by trapzoid method.
definite_integral_simpson.rbRuby script to definite integral by simpson method.
taylor_expansion.rbRuby script to calc taylor expansion of exp(x).
taylor_expansion_cos.rbRuby script to calc taylor expansion of cos.
nonlinear_equation.rbRuby script to calc nonlinear equation by bisection method.
nonlinear_equation_newtown.rbRuby script to calc nonlinear equation by newtown method.
interpolate_lagrange.rbRuby script to interpolate with Lagrange method.
benchmark.rbRuby script for benchmarks.
month_list.rbOctopress plugin to generate a month list.
archive_generator.rbOctopress plugin to generate monthly archive pages.
nanoc_helper_pager.rbRuby script to generate pager for each article.
nanoc_helper_related_articles.rbRuby script to generate a list of related articles.
unicorn_railsScript to start unicorn.
unicorn.rbConfiguration of unicorn on rails application.
test_mecab.rbRuby script to test of mecab.
twitter_get_list_members.rbRuby script to get members of lists by Twitter API.
twitter_get_lists.rbRuby script to get twitter lists by Twitter API.

Sponsored Link

Now Loading ...

Sponsored Link