uva 10808 - Rational Resistors(基尔霍夫定律+高斯消元)

题目链接:uva 10808 - Rational Resistors

题目大意:给出一个博阿含n个节点,m条导线的电阻网络,求节点a和b之间的等效电阻。

解题思路:基尔霍夫定律,任何一点的电流向量为0。就是说有多少电流流入该节点,就有多少电流流出。

对于每次询问的两点间等效电阻,先判断说两点是否联通,不连通的话绝逼是1/0(无穷大)。联通的话,将同一个联通分量上的节点都扣出来,假设电势作为变元,然后根据基尔霍夫定律列出方程,因为对于每个节点的电流向量为0,所以每个节点都有一个方程,所有与该节点直接连接的都会有电流流入,并且最后总和为0,(除了a,b两点,一个为1,一个为-1)。用高斯消元处理,但是这样列出的方程组不能准确求出节点的电势,只能求出各个节点之间电势的关系。所以我们将a点的电势置为0,那么用求出的b点电势减去0就是两点间的电压,又因为电流设为1,所以等效电阻就是电压除以电流。

#include <cstdio>
#include <cstring>
#include <algorithm>

using namespace std;

typedef long long type;

struct Fraction {
    type member; // 分子;
    type denominator; // 分母;

    Fraction (type member = 0, type denominator = 1);
    void operator = (type x) { this->set(x, 1); }
    Fraction operator * (const Fraction& u);
    Fraction operator / (const Fraction& u);
    Fraction operator + (const Fraction& u);
    Fraction operator - (const Fraction& u);

    Fraction operator *= (const Fraction& u) { return *this = *this * u; }
    Fraction operator /= (const Fraction& u) { return *this = *this / u; }
    Fraction operator += (const Fraction& u) { return *this = *this + u; }
    Fraction operator -= (const Fraction& u) { return *this = *this - u; }

    void set(type member, type denominator);
};

inline type gcd (type a, type b) {
    return b == 0 ? (a > 0 ? a : -a) : gcd(b, a % b);
}

inline type lcm (type a, type b) {
    return a / gcd(a, b) * b;
}

/*Code*/
/////////////////////////////////////////////////////
const int maxn = 105;
typedef long long ll;
typedef Fraction Mat[maxn][maxn];

int N, M, f[maxn];
Mat G, A;

bool cmp (Fraction& a, Fraction& b) {
    return a.member * b.denominator < b.member * a.denominator;
}

inline int getfar (int x) {
    return x == f[x] ? x : f[x] = getfar(f[x]);
}

inline void link (int u, int v) {
    int p = getfar(u);
    int q = getfar(v);
    f[p] = q;
}

void init () {
    scanf("%d%d", &N, &M);

    for (int i = 0; i < N; i++) {
        f[i] = i;
        for (int j = 0; j < N; j++)
            G[i][j] = 0;
    }

    int u, v;
    ll R;
    for (int i = 0; i < M; i++) {
        scanf("%d%d%lld", &u, &v, &R);

        if (u == v)
            continue;

        link(u, v);
        G[u][v] += Fraction(1, R);
        G[v][u] += Fraction(1, R);
    }
}

Fraction gauss_elimin (int u, int v, int n) {

    /*
    printf("\n");

    for (int i = 0; i < n; i++) {
        for (int j = 0; j <= n; j++)
            printf("%lld/%lld ", A[i][j].member,  A[i][j].denominator);
        printf("\n");
    }
    */

    for (int i = 0; i < n; i++) {
        int r;

        for (int j = i; j < n; j++)
            if (A[j][i].member) {
                r = j;
                break;
            }

        if (r != i) {
            for (int j = 0; j <= n; j++)
                swap(A[i][j], A[r][j]);
        }

        if (A[i][i].member == 0)
            continue;

        for (int j = i + 1; j < n; j++) {
            Fraction t = A[j][i] / A[i][i];
            for (int k = 0; k <= n; k++)
                A[j][k] -= A[i][k] * t;
        }
    }

    for (int i = n-1; i >= 0; i--) {
        for (int j = i+1; j < n; j++) {
            if (A[j][j].member)
                A[i][n] -= A[i][j] * A[j][n] / A[j][j];
        }
    }

    /*
       Fraction U = A[u][n] / A[u][u];
       printf("%lld/%lld!\n", A[u][n].member, A[u][n].denominator);
       printf("%lld/%lld!\n", A[u][u].member, A[u][u].denominator);
       printf("%lld/%lld\n", U.member, U.denominator);

       Fraction V = A[v][n] / A[v][v];
       printf("%lld/%lld\n", V.member, V.denominator);
       */

    return A[u][n] / A[u][u] - A[v][n] / A[v][v];
}

Fraction solve (int u, int v) {
    int n = 0, hash[maxn];
    int hu, hv;

    for (int i = 0; i < N; i++) {
        if (i == u)
            hu = u;

        if (i == v)
            hv = v;

        if (getfar(i) == getfar(u))
            hash[n++] = i;
    }

    n++;
    for (int i = 0; i <= n; i++) {
        for (int j = 0; j <= n; j++)
            A[i][j] = 0;
    }

    for (int i = 0; i < n - 1; i++) {
        for (int j = 0; j < n - 1; j++) {
            if (i == j)
                continue;

            int p = hash[i];
            int q = hash[j];

            A[i][i] += G[p][q];
            A[i][j] -= G[p][q];
        }
    }

    A[hu][n] = 1;
    A[hv][n] = -1;
    A[n-1][0] = 1;
    return gauss_elimin (hu, hv, n);
}

int main () {
    int cas;
    scanf("%d", &cas);

    for (int kcas = 1; kcas <= cas; kcas++) {
        init();

        int Q, u, v;
        scanf("%d", &Q);
        printf("Case #%d:\n", kcas);
        for (int i = 0; i < Q; i++) {
            scanf("%d%d", &u, &v);

            printf("Resistance between %d and %d is ", u, v);
            if (getfar(u) == getfar(v)) {
                Fraction ans = solve(u, v);
                printf("%lld/%lld\n", ans.member, ans.denominator);
            } else
                printf("1/0\n");
        }
        printf("\n");
    }
    return 0;
}

/////////////////////////////////////////////////////

Fraction::Fraction (type member, type denominator) {
    this->set(member, denominator);
}

Fraction Fraction::operator * (const Fraction& u) {
    type tmp_p = gcd(member, u.denominator);
    type tmp_q = gcd(u.member, denominator);
    return Fraction( (member / tmp_p) * (u.member / tmp_q), (denominator / tmp_q) * (u.denominator / tmp_p) );
}

Fraction Fraction::operator / (const Fraction& u) {
    type tmp_p = gcd(member, u.member);
    type tmp_q = gcd(denominator, u.denominator);
    return Fraction( (member / tmp_p) * (u.denominator / tmp_q), (denominator / tmp_q) * (u.member / tmp_p));
}

Fraction Fraction::operator + (const Fraction& u) {
    type tmp_l = lcm (denominator, u.denominator);
    return Fraction(tmp_l / denominator * member + tmp_l / u.denominator * u.member, tmp_l);
}

Fraction Fraction::operator - (const Fraction& u) {
    type tmp_l = lcm (denominator, u.denominator);
    return Fraction(tmp_l / denominator * member - tmp_l / u.denominator * u.member, tmp_l);
}

void Fraction::set (type member, type denominator) {

    if (denominator == 0) {
        denominator = 1;
        member = 0;
    }

    if (denominator < 0) {
        denominator = -denominator;
        member = -member;
    }

    type tmp_d = gcd(member, denominator);
    this->member = member / tmp_d;
    this->denominator = denominator / tmp_d;
}

uva 10808 - Rational Resistors(基尔霍夫定律+高斯消元),布布扣,bubuko.com

时间: 2024-12-01 07:39:10

uva 10808 - Rational Resistors(基尔霍夫定律+高斯消元)的相关文章

UVA 10808 - Rational Resistors(高斯消元+并查集+分数+基尔霍夫定律)

UVA 10808 - Rational Resistors 题意:给定一些结点,有一些电阻,电阻分布在边上,给定一个电路图,每次询问两点,求这两点间的等效电阻 思路:根据基尔霍夫定律,任意一点的电流向量为0,这样就能设每个结点的电势,列出方程,利用高斯消元求解,对于无解的情况,肯定是两点不能连通,这个可以利用并查集判断. 此外这题有个很坑的地方啊,就是高斯消元的姿势不够优美就会爆long long 代码: #include <cstdio> #include <cstring>

uva 1560 - Extended Lights Out(枚举 | 高斯消元)

题目链接:uva 1560 - Extended Lights Out 题目大意:给定一个5?6的矩阵,每个位置上有一个灯和开关,初始矩阵表示灯的亮暗情况,如果按了这个位置的开关,将会导致周围包括自己位置的灯状态变换,求一个按开关位置,保证所有灯都灭掉. 解题思路: 枚举,枚举第一行的状态,然后递推出后面四行的状态. 高斯消元,对于每个位置对定变量,这样列出30个方程求解. C++ 枚举 #include <cstdio> #include <cstring> #include &

UVA 10828 - Back to Kernighan-Ritchie(概率+高斯消元)

UVA 10828 - Back to Kernighan-Ritchie 题目链接 题意:给图一个流程图,有结点的流程,每次进入下一个流程概率是均等的,有q次询问,求出每次询问结点的执行期望 思路:高斯消元,每个结点的期望等于所有前趋结点的期望/出度的和,由于存在无限循环的情况,不能直接递推,利用高斯消元去做,判断无解的情况既为无限循环,注意如果一个式自xi为0,但是xn也为0,xi值应该是0,表示无法到达 代码: #include <cstdio> #include <cstring

UVA 1397 - The Teacher&#39;s Side of Math(高斯消元)

UVA 1397 - The Teacher's Side of Math 题目链接 题意:给定一个x=a1/m+b1/n,求原方程组 思路:由于m*n最多20,所有最高项只有20,然后可以把每个此项拆分,之后得到n种不同无理数,每一项为0,就可以设系数为变元,构造方程进行高斯消元 一开始用longlong爆了,换成分数写法也爆了,又不想改高精度,最后是机智的用了double型过的,不过用double精度问题,所以高斯消元的姿势要正确,并且最后输出要注意-0的情况 代码: #include <c

uva 1564 - Widget Factory(高斯消元+逆元)

题目链接:uva 1564 - Widget Factory 题目大意:n种零件,m次工作日程,零件序号从1到n,给出m次工作日程的信息,x,s,e,表示生产了x个零件,从星期s开始到星期e(有可能是多个星期),然后给出生产的x个零件的序号.求每个零件被生产需要多少天(保证在3到10天) 解题思路:因为不能确定每个工作日程具体生产了几天,所以对应列出的方程均为线性模方程(模7),所以在高斯消元的过程中遇到除法要转换成乘上逆元. #include <cstdio> #include <cs

UVA 1560 - Extended Lights Out(高斯消元)

UVA 1560 - Extended Lights Out 题目链接 题意:给定一个矩阵,1代表开着灯,0代表关灯,没按一个开关,周围4个位置都会变化,问一个按的方法使得所有灯都变暗 思路:两种做法: 1.枚举递推 这个比较简单,就枚举第一行,然后递推过去,每次如果上一行是亮灯,则下一行开关必须按下去 2.高斯消元, 这个做法比较屌一些,每个位置对应上下左右中5个位置可以列出一个异或表达式,然后30个位置对应30个异或表达式,利用高斯消元法就能求出每个位置的解了 代码: 高斯消元法: #inc

UVa 10828 Back to Kernighan-Ritchie 高斯消元+概率DP

题目来源:UVa 10828 Back to Kernighan-Ritchie 题意:从1开始 每次等概率从一个点到和他相邻的点 有向 走到不能走停止 求停止时每个点的期望 思路:写出方程消元 方程有唯一解 多解 无解的情况 有环 一直再环里无法停止算无穷大 从1不能到的点期望为0 #include <cstdio> #include <cstring> #include <algorithm> #include <vector> #include <

UVA 1397 - The Teacher&amp;#39;s Side of Math(高斯消元)

UVA 1397 - The Teacher's Side of Math 题目链接 题意:给定一个x=a1/m+b1/n.求原方程组 思路:因为m*n最多20,全部最高项仅仅有20.然后能够把每一个此项拆分.之后得到n种不同无理数,每一项为0.就能够设系数为变元.构造方程进行高斯消元 一開始用longlong爆了.换成分数写法也爆了,又不想改高精度.最后是机智的用了double型过的,只是用double精度问题,所以高斯消元的姿势要正确,而且最后输出要注意-0的情况 代码: #include

UVA 1564 - Widget Factory(高斯消元)

UVA 1564 - Widget Factory 题目链接 题意:n种零件, 给定m个制作时间,每段时间制作k个零件,每种零件有一个制作时间,每段时间用Mon到Sun表示,求每个零件的制作时间,还要判断一下多解和无解的情况 思路:对于每段时间列出一个方程,这样一共列出m个方程解n个变元,利用高斯消元去求解,注意每个方程都是MOD 7的,所以在高斯消元过程中遇到除法要求该数字%7的逆元去进行运算 代码: #include <cstdio> #include <cstring> #i