t 分布

/****************************/
/* t分布の計算             */
/*      coded by Y.Suganuma */
/****************************/
#include <stdio.h>

double normal(double, double *);
double p_normal(int *);
double bisection(double(*)(double), double, double, double, double, int, int *);
double normal_f(double);
double t(double, double *, int);
double p_t(int *);
double gamma(double, int *);
double newton(double(*)(double), double(*)(double), double, double,
              double, int, int *);
double t_f(double);
double t_df(double);

double p;     // α%値を計算するとき時α/100を設定
int dof;      // 自由度
              // 上の2つの変数は,必ず,この位置で定義しておく必要がある

int main()
{
	double h, x, x1, x2, y, z;
	int sw;
	char file1[100], file2[100];
	FILE *out1, *out2;

	printf("自由度は? ");
	scanf("%d", &dof);
	printf("目的とする結果は? \n");
	printf("     =0 : 確率の計算( P(X = x) 及び P(X < x) の値)\n");
	printf("     =1 : p%値( P(X > u) = 0.01p となるuの値) ");
	scanf("%d", &sw);

	if (sw == 0) {

		printf("グラフ出力?(=1: yes,  =0: no) ");
		scanf("%d", &sw);
					// 密度関数と分布関数の値
		if (sw == 0) {
			printf("   データは? ");
			scanf("%lf", &x);
			y = t(x, &z, dof);
			printf("P(X = %f) = %f,  P( X < %f) = %f (自由度 = %d)\n", x, z, x, y, dof);
		}
					// グラフ出力
		else {
			printf("   密度関数のファイル名は? ");
			scanf("%s", file1);
			printf("   分布関数のファイル名は? ");
			scanf("%s", file2);
			out1 = fopen(file1,"w");
			out2 = fopen(file2,"w");
			printf("   データの下限は? ");
			scanf("%lf", &x1);
			printf("   データの上限は? ");
			scanf("%lf", &x2);
			printf("   刻み幅は? ");
			scanf("%lf", &h);
			for (x = x1; x < x2+0.5*h; x += h) {
				y = t(x, &z, dof);
				fprintf(out1, "%f %f\n", x, z);
				fprintf(out2, "%f %f\n", x, y);
			}
		}
	}
					// %値
	else {
		printf("%の値は? ");
		scanf("%lf", &x);
		p = 0.01 * x;
		if (p < 1.0e-7)
			printf("%f%値 = ∞ (自由度 = %d)\n", x, dof);
		else if ((1.0-p) < 1.0e-7)
			printf("%f%値 = -∞ (自由度 = %d)\n", x, dof);
		else {
			y = p_t(&sw);
			printf("%f%値 = %f  sw %d (自由度 = %d)\n", x, y, sw, dof);
		}
	}

	return 0;
}

/**************************************************/
/* t分布の計算(P(X = tt), P(X < tt))           */
/* (自由度が∞の時の値はN(0,1)を利用して下さい) */
/*      dd : P(X = tt)                            */
/*      df : 自由度                               */
/*      return : P(X < tt)                        */
/**************************************************/
#include <math.h>

double t(double tt, double *dd, int df)
{
	double pi = 4.0 * atan(1.0);
	double p, pp, sign, t2, u, x;
	int ia, i1;

	sign = (tt < 0.0) ? -1.0 : 1.0;
	if (fabs(tt) < 1.0e-10)
		tt = sign * 1.0e-10;
	t2 = tt * tt;
	x  = t2 / (t2 + df);

	if(df%2 != 0) {
		u  = sqrt(x*(1.0-x)) / pi;
		p  = 1.0 - 2.0 * atan2(sqrt(1.0-x), sqrt(x)) / pi;
		ia = 1;
	}

	else {
		u  = sqrt(x) * (1.0 - x) / 2.0;
		p  = sqrt(x);
		ia = 2;
	}

	if (ia != df) {
		for (i1 = ia; i1 <= df-2; i1 += 2) {
			p += 2.0 * u / i1;
			u *= (1.0 + i1) / i1 * (1.0 - x);
		}
	}

	*dd = u / fabs(tt);
	pp  = 0.5 + 0.5 * sign * p;

	return pp;
}

/**************************************************/
/* t分布のp%値(P(X > u) = 0.01p)             */
/* (自由度が∞の時の値はN(0,1)を利用して下さい) */
/*      ind : >= 0 : normal(収束回数)           */
/*            = -1 : 収束しなかった               */
/**************************************************/
#include <math.h>

double p_t(int *ind)
{
	double pi = 4.0 * atan(1.0);
	double c, df, df2, e, pis, p2, tt = 0.0, t0, x, yq;

	pis = sqrt(pi);
	df  = (double)dof;
	df2 = 0.5 * df;
					// 自由度=1
	if (dof == 1)
		tt = tan(pi*(0.5-p));

	else {
					// 自由度=2
		if (dof == 2) {
			c   = (p > 0.5) ? -1.0 : 1.0;
			p2  = (1.0 - 2.0 * p);
			p2 *= p2;
			tt  = c * sqrt(2.0 * p2 / (1.0 - p2));
		}
					// 自由度>2
		else {

			yq = p_normal(ind);   // 初期値計算のため

			if (*ind >= 0) {

				x  = 1.0 - 1.0 / (4.0 * df);
				e  = x * x - yq * yq / (2.0 * df);

				if (e > 0.5)
					t0 = yq / sqrt(e);
				else {
					x  = sqrt(df) / (pis * p * df * gamma(df2, ind) / gamma(df2+0.5, ind));
					t0 = pow(x, 1.0/df);
				}
						// ニュートン法
				tt = newton(t_f, t_df, t0, 1.0e-6, 1.0e-10, 100, ind);
			}
		}
	}

	return tt;
}

/****************************************/
/* Γ(x)の計算(ガンマ関数,近似式) */
/*      ier : =0 : normal               */
/*            =-1 : x=-n (n=0,1,2,・・・)  */
/*      return : 結果                   */
/****************************************/
#include <math.h>

double gamma(double x, int *ier)
{
	double err, g, s, t, v, w, y;
	long k;

	*ier = 0;

	if (x > 5.0) {
		v = 1.0 / x;
		s = ((((((-0.000592166437354 * v + 0.0000697281375837) * v +
            0.00078403922172) * v - 0.000229472093621) * v -
            0.00268132716049) * v + 0.00347222222222) * v +
            0.0833333333333) * v + 1.0;
		g = 2.506628274631001 * exp(-x) * pow(x,x-0.5) * s;
	}

	else {

		err = 1.0e-20;
		w   = x;
		t   = 1.0;

		if (x < 1.5) {

			if (x < err) {
				k = (long)x;
				y = (double)k - x;
				if (fabs(y) < err || fabs(1.0-y) < err)
					*ier = -1;
			}

			if (*ier == 0) {
				while (w < 1.5) {
					t /= w;
					w += 1.0;
				}
			}
		}

		else {
			if (w > 2.5) {
				while (w > 2.5) {
					w -= 1.0;
					t *= w;
				}
			}
		}

		w -= 2.0;
		g  = (((((((0.0021385778 * w - 0.0034961289) * w + 
             0.0122995771) * w - 0.00012513767) * w + 0.0740648982) * w +
             0.0815652323) * w + 0.411849671) * w + 0.422784604) * w +
             0.999999926;
		g *= t;
	}

	return g;
}

/********************************/
/* 1.0 - p - P(X > x)(関数値) */
/********************************/
double t_f(double x)
{
	double y;

	return t(x, &y, dof) - 1.0 + p;
}

/**************************/
/* P(X = x)(関数の微分) */
/**************************/
double t_df(double x)
{
	double y, z;

	z = t(x, &y, dof);

	return y;
}

/*****************************************************/
/* Newton法による非線形方程式(f(x)=0)の解            */
/*      fn : f(x)を計算する関数名                    */
/*      dfn : f(x)の微分を計算する関数名             */
/*      x0 : 初期値                                  */
/*      eps1 : 終了条件1(|x(k+1)-x(k)|<eps1)   */
/*      eps2 : 終了条件2(|f(x(k))|<eps2)       */
/*      max : 最大試行回数                           */
/*      ind : 実際の試行回数                         */
/*            (負の時は解を得ることができなかった) */
/*      return : 解                                  */
/*****************************************************/
#include <math.h>

double newton(double(*f)(double), double(*df)(double), double x0,
              double eps1, double eps2, int max, int *ind)
{
	double g, dg, x, x1;
	int sw;

	x1   = x0;
	x    = x1;
	*ind = 0;
	sw   = 0;

	while (sw == 0 && *ind >= 0) {

		sw    = 1;
		*ind += 1;
		g     = (*f)(x1);

		if (fabs(g) > eps2) {
			if (*ind <= max) {
				dg = (*df)(x1);
				if (fabs(dg) > eps2) {
					x = x1 - g / dg;
					if (fabs(x-x1) > eps1 && fabs(x-x1) > eps1*fabs(x)) {
						x1 = x;
						sw = 0;
					}
				}
				else
					*ind = -1;
			}
			else
				*ind = -1;
		}
	}

	return x;
}

/*************************************************/
/* 標準正規分布N(0,1)の計算(P(X = x), P(X < x))*/
/*      w : P(X = x)                             */
/*      return : P(X < x)                        */
/*************************************************/
#include <math.h>

double normal(double x, double *w)
{
	double pi = 4.0 * atan(1.0);
	double y, z, P;
/*
     確率密度関数(定義式)
*/
	*w = exp(-0.5 * x * x) / sqrt(2.0*pi);
/*
     確率分布関数(近似式を使用)
*/
	y = 0.70710678118654 * fabs(x);
	z = 1.0 + y * (0.0705230784 + y * (0.0422820123 +
        y * (0.0092705272 + y * (0.0001520143 + y * (0.0002765672 +
        y * 0.0000430638)))));
	P = 1.0 - pow(z,-16.0);

	if (x < 0.0)
		P = 0.5 - 0.5 * P;
	else
		P = 0.5 + 0.5 * P;

	return P;
}

/******************************************************************/
/* 標準正規分布N(0,1)のp%値(P(X > u) = 0.01p)(二分法を使用) */
/*      ind : >= 0 : normal(収束回数)                           */
/*            = -1 : 収束しなかった                               */
/******************************************************************/
double p_normal(int *ind)
{
	double u;
	int sw;

	u    = bisection(normal_f, -7.0, 7.0, 1.0e-6, 1.0e-10, 100, &sw);
	*ind = sw;

	return u;
}

/********************************/
/* 1.0 - p - P(X > x)(関数値) */
/********************************/
double normal_f(double x)
{
	double y;

	return 1.0 - p - normal(x, &y);
}

/*********************************************************/
/* 二分法による非線形方程式(f(x)=0)の解                  */
/*      fn : f(x)を計算する関数名                        */
/*      x1,x2 : 初期値                                   */
/*      eps1 : 終了条件1(|x(k+1)-x(k)|<eps1)       */
/*      eps2 : 終了条件2(|f(x(k))|<eps2)           */
/*      max : 最大試行回数                               */
/*      ind : 実際の試行回数                             */
/*            (負の時は解を得ることができなかった)     */
/*      return : 解                                      */
/*********************************************************/
#include <math.h>

double bisection(double(*f)(double), double x1, double x2,
                 double eps1, double eps2, int max, int *ind)
{
	double f0, f1, f2, x0 = 0.0;
	int sw;

	f1 = (*f)(x1);
	f2 = (*f)(x2);

	if (f1*f2 > 0.0)
		*ind = -1;

	else {
		*ind = 0;
		if (f1*f2 == 0.0)
			x0 = (f1 == 0.0) ? x1 : x2;
		else {
			sw = 0;
			while (sw == 0 && *ind >= 0) {
				sw    = 1;
				*ind += 1;
				x0    = 0.5 * (x1 + x2);
				f0    = (*f)(x0);

				if (fabs(f0) > eps2) {
					if (*ind <= max) {
						if (fabs(x1-x2) > eps1 && fabs(x1-x2) > eps1*fabs(x2)) {
							sw = 0;
							if (f0*f1 < 0.0) {
								x2 = x0;
								f2 = f0;
							}
							else {
								x1 = x0;
								f1 = f0;
							}
						}
					}
					else
						*ind = -1;
				}
			}
		}
	}

	return x0;
}